]> https://gitweb.dealii.org/ - dealii.git/commitdiff
new heads
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 22 Feb 2000 20:31:34 +0000 (20:31 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 22 Feb 2000 20:31:34 +0000 (20:31 +0000)
git-svn-id: https://svn.dealii.org/trunk@2477 0785d39b-7218-0410-832d-ea1e28bc413d

48 files changed:
deal.II/deal.II/source/dofs/dof_accessor.cc
deal.II/deal.II/source/dofs/dof_constraints.cc
deal.II/deal.II/source/dofs/dof_handler.cc
deal.II/deal.II/source/dofs/dof_renumbering.cc
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_lib.criss_cross.cc
deal.II/deal.II/source/fe/fe_lib.cubic.cc
deal.II/deal.II/source/fe/fe_lib.dg.cc
deal.II/deal.II/source/fe/fe_lib.dg.constant.cc
deal.II/deal.II/source/fe/fe_lib.linear.cc
deal.II/deal.II/source/fe/fe_lib.quadratic.cc
deal.II/deal.II/source/fe/fe_lib.quartic.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/fe_values.cc
deal.II/deal.II/source/fe/q1_mapping.cc
deal.II/deal.II/source/fe/q1_mapping.jacobians.cc
deal.II/deal.II/source/grid/geometry_info.cc
deal.II/deal.II/source/grid/grid_generator.cc
deal.II/deal.II/source/grid/grid_in.cc
deal.II/deal.II/source/grid/grid_out.all_dimensions.cc
deal.II/deal.II/source/grid/grid_out.cc
deal.II/deal.II/source/grid/intergrid_map.cc
deal.II/deal.II/source/grid/persistent_tria.cc
deal.II/deal.II/source/grid/tria.all_dimensions.cc
deal.II/deal.II/source/grid/tria.cc
deal.II/deal.II/source/grid/tria_accessor.cc
deal.II/deal.II/source/grid/tria_boundary.cc
deal.II/deal.II/source/grid/tria_boundary_lib.cc
deal.II/deal.II/source/multigrid/mg_base.cc
deal.II/deal.II/source/multigrid/mg_dof_accessor.cc
deal.II/deal.II/source/multigrid/mg_dof_handler.cc
deal.II/deal.II/source/multigrid/mg_dof_tools.cc
deal.II/deal.II/source/multigrid/mg_smoother.cc
deal.II/deal.II/source/multigrid/multigrid.cc
deal.II/deal.II/source/numerics/assembler.cc
deal.II/deal.II/source/numerics/base.cc
deal.II/deal.II/source/numerics/data_io.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/data_out_stack.cc
deal.II/deal.II/source/numerics/equation.cc
deal.II/deal.II/source/numerics/error_estimator.cc
deal.II/deal.II/source/numerics/histogram.cc
deal.II/deal.II/source/numerics/matrices.cc
deal.II/deal.II/source/numerics/solution_transfer.cc
deal.II/deal.II/source/numerics/time_dependent.cc
deal.II/deal.II/source/numerics/vectors.all_dimensions.cc
deal.II/deal.II/source/numerics/vectors.cc

index 20aade1bcde7540024fd10a85242ed2f9a6cf7f5..7989c1cc92653623adab6cafad846fe0d93ca3c7 100644 (file)
@@ -1,6 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-
+//----------------------------  dof_accessor.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_accessor.cc  ---------------------------
 
 
 #include <dofs/dof_accessor.h>
 #include <vector>
 
 
-
-
-
 /*------------------------- Functions: DoFLineAccessor -----------------------*/
 
 
-
 template <int dim>
 void DoFObjectAccessor<1, dim>::set_dof_index (const unsigned int i,
                                               const unsigned int index) const
@@ -40,8 +45,6 @@ void DoFObjectAccessor<1, dim>::set_dof_index (const unsigned int i,
 };
 
 
-
-
 template <int dim>
 void DoFObjectAccessor<1, dim>::set_vertex_dof_index (const unsigned int vertex,
                                                      const unsigned int i,
@@ -60,7 +63,6 @@ void DoFObjectAccessor<1, dim>::set_vertex_dof_index (const unsigned int vertex,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<1, dim>::
 distribute_local_to_global (const Vector<double> &local_source,
@@ -85,7 +87,6 @@ distribute_local_to_global (const Vector<double> &local_source,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<1, dim>::
 distribute_local_to_global (const FullMatrix<double> &local_source,
@@ -115,7 +116,6 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -146,7 +146,6 @@ DoFObjectAccessor<1,dim>::get_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -176,8 +175,6 @@ DoFObjectAccessor<1,dim>::set_dof_values (const Vector<number> &local_values,
 };
 
 
-
-
 /*------------------------- Functions: DoFQuadAccessor -----------------------*/
 
 
@@ -197,7 +194,6 @@ void DoFObjectAccessor<2, dim>::set_dof_index (const unsigned int i,
 };
 
 
-
 template <int dim>
 void
 DoFObjectAccessor<2, dim>::set_vertex_dof_index (const unsigned int vertex,
@@ -217,7 +213,6 @@ DoFObjectAccessor<2, dim>::set_vertex_dof_index (const unsigned int vertex,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<2, dim>::
 distribute_local_to_global (const Vector<double> &local_source,
@@ -243,7 +238,6 @@ distribute_local_to_global (const Vector<double> &local_source,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<2, dim>::
 distribute_local_to_global (const FullMatrix<double> &local_source,
@@ -274,7 +268,6 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -309,7 +302,6 @@ DoFObjectAccessor<2,dim>::get_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -344,10 +336,6 @@ DoFObjectAccessor<2,dim>::set_dof_values (const Vector<number> &local_values,
 };
 
 
-
-
-
-
 /*------------------------- Functions: DoFHexAccessor -----------------------*/
 
 
@@ -367,7 +355,6 @@ void DoFObjectAccessor<3, dim>::set_dof_index (const unsigned int i,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<3, dim>::set_vertex_dof_index (const unsigned int vertex,
                                                      const unsigned int i,
@@ -386,7 +373,6 @@ void DoFObjectAccessor<3, dim>::set_vertex_dof_index (const unsigned int vertex,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<3, dim>::
 distribute_local_to_global (const Vector<double> &local_source,
@@ -413,7 +399,6 @@ distribute_local_to_global (const Vector<double> &local_source,
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<3, dim>::
 distribute_local_to_global (const FullMatrix<double> &local_source,
@@ -446,7 +431,6 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -485,7 +469,6 @@ DoFObjectAccessor<3,dim>::get_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -524,13 +507,9 @@ DoFObjectAccessor<3,dim>::set_dof_values (const Vector<number> &local_values,
 };
 
 
-
-
-
 /*------------------------- Functions: DoFCellAccessor -----------------------*/
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -544,7 +523,6 @@ DoFCellAccessor<1>::face (const unsigned int) const
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -557,7 +535,6 @@ DoFCellAccessor<2>::face (const unsigned int i) const
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -570,8 +547,6 @@ DoFCellAccessor<3>::face (const unsigned int i) const
 #endif
 
 
-
-
 template <int dim>
 template <typename number>
 void
@@ -634,7 +609,6 @@ DoFCellAccessor<dim>::get_interpolated_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -671,11 +645,6 @@ DoFCellAccessor<dim>::set_dof_values_by_interpolation (const Vector<number> &loc
 };
 
 
-
-
-
-
-
 // explicit instantiations
 
 
@@ -793,7 +762,6 @@ set_dof_values_by_interpolation(const Vector<float> &,
                                Vector<float>       &) const;
 
 
-
 #if deal_II_dimension == 1
 template class DoFObjectAccessor<1, 1>;
 #endif
@@ -808,7 +776,6 @@ template class TriaActiveIterator<2,DoFObjectAccessor<1, 2> >;
 #endif
 
 
-
 #if deal_II_dimension == 3
 template class DoFObjectAccessor<1, 3>;
 template class DoFObjectAccessor<2, 3>;
index 6c6315daf7002b8b1676dc3918e3d1dfe7f7c69e..2b9e6178f89a612051fb5bc02413be9fda1d49c4 100644 (file)
@@ -1,6 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-
+//----------------------------  dof_constraints.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_constraints.cc  ---------------------------
 
 
 #include <dofs/dof_constraints.h>
@@ -11,7 +20,6 @@
 #include <numeric>
 
 
-
 inline
 bool
 ConstraintMatrix::ConstraintLine::operator < (const ConstraintLine &a) const
@@ -20,13 +28,10 @@ ConstraintMatrix::ConstraintLine::operator < (const ConstraintLine &a) const
 };
 
 
-
-
 ConstraintMatrix::ConstraintMatrix () :
                lines(), sorted(false) {};
 
 
-
 void ConstraintMatrix::add_line (const unsigned int line) {
   Assert (sorted==false, ExcMatrixIsClosed());
 
@@ -41,7 +46,6 @@ void ConstraintMatrix::add_line (const unsigned int line) {
   lines.push_back (ConstraintLine());
   lines.back().line = line;
 };
-  
 
 
 void ConstraintMatrix::add_entry (const unsigned int line,
@@ -85,8 +89,6 @@ void ConstraintMatrix::add_entry (const unsigned int line,
 };
 
 
-
-
 void ConstraintMatrix::close () {
   Assert (sorted==false, ExcMatrixIsClosed());
 
@@ -113,7 +115,6 @@ void ConstraintMatrix::close () {
   sorted = true;
 };
 
-         
 
 void ConstraintMatrix::clear () {
   lines = vector<ConstraintLine>();
@@ -121,7 +122,6 @@ void ConstraintMatrix::clear () {
 };
 
 
-
 void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
                                 SparsityPattern       &condensed) const {
   Assert (sorted == true, ExcMatrixNotClosed());
@@ -129,8 +129,8 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
   Assert (uncondensed.n_rows() == uncondensed.n_cols(),
          ExcMatrixNotSquare());
 
-  
-                                  // store for each line of the matrix
+
+// store for each line of the matrix
                                   // its new line number
                                   // after compression. If the shift is
                                   // -1, this line will be condensed away
@@ -167,8 +167,8 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
       else
        new_line.push_back (row-shift);
 
-  next_constraint = lines.begin();
+
+next_constraint = lines.begin();
                                   // note: in this loop we need not check
                                   // whether #next_constraint# is a valid
                                   // iterator, since #next_constraint# is
@@ -230,7 +230,6 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
 };
 
 
-
 void ConstraintMatrix::condense (SparsityPattern &sparsity) const {
   Assert (sorted == true, ExcMatrixNotClosed());
   Assert (sparsity.is_compressed() == false, ExcMatrixIsClosed());
@@ -309,14 +308,12 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const {
 };
 
 
-
 unsigned int ConstraintMatrix::n_constraints () const
 {
   return lines.size();
 };
 
 
-
 bool ConstraintMatrix::is_constrained (const unsigned int index) const 
 {
   if (sorted == true)
@@ -341,7 +338,6 @@ bool ConstraintMatrix::is_constrained (const unsigned int index) const
 };
 
 
-
 void ConstraintMatrix::print (ostream &out) const {
   for (unsigned int i=0; i!=lines.size(); ++i)
     for (unsigned int j=0; j!=lines[i].entries.size(); ++j)
index 07246c45d21072e9308e8cda63edc6430b40084f..c8c875f41023b056075a359021e6551f3c0734bb 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998, 1999 */
+//----------------------------  dof_handler.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_handler.cc  ---------------------------
 
 
 #include <dofs/dof_handler.h>
@@ -16,7 +26,6 @@
 #include <algorithm>
 
 
-
 template <int dim>
 DoFHandler<dim>::DoFHandler (Triangulation<dim> &tria) :
                tria(&tria),
@@ -24,16 +33,11 @@ DoFHandler<dim>::DoFHandler (Triangulation<dim> &tria) :
 {};
 
 
-
 template <int dim>
 DoFHandler<dim>::~DoFHandler ()
 {};
 
 
-
-
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -43,7 +47,6 @@ DoFHandler<1>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::begin (const unsigned int level) const {
@@ -51,7 +54,6 @@ DoFHandler<1>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::begin_active (const unsigned int level) const {
@@ -59,7 +61,6 @@ DoFHandler<1>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::end () const {
@@ -67,7 +68,6 @@ DoFHandler<1>::end () const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::last_raw () const {
@@ -75,7 +75,6 @@ DoFHandler<1>::last_raw () const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::last_raw (const unsigned int level) const {
@@ -83,7 +82,6 @@ DoFHandler<1>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::last () const {
@@ -91,7 +89,6 @@ DoFHandler<1>::last () const {
 };
 
 
-
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::last (const unsigned int level) const {
@@ -99,7 +96,6 @@ DoFHandler<1>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::last_active () const {
@@ -107,7 +103,6 @@ DoFHandler<1>::last_active () const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::last_active (const unsigned int level) const {
@@ -115,7 +110,6 @@ DoFHandler<1>::last_active (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::begin_raw_face (const unsigned int) const {
@@ -124,7 +118,6 @@ DoFHandler<1>::begin_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::begin_face (const unsigned int) const {
@@ -133,7 +126,6 @@ DoFHandler<1>::begin_face (const unsigned int) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::begin_active_face (const unsigned int) const {
@@ -142,7 +134,6 @@ DoFHandler<1>::begin_active_face (const unsigned int) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::end_face () const {
@@ -151,7 +142,6 @@ DoFHandler<1>::end_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::last_raw_face () const {
@@ -160,7 +150,6 @@ DoFHandler<1>::last_raw_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::last_raw_face (const unsigned int) const {
@@ -169,7 +158,6 @@ DoFHandler<1>::last_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::last_face () const {
@@ -178,7 +166,6 @@ DoFHandler<1>::last_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::last_face (const unsigned int) const {
@@ -187,7 +174,6 @@ DoFHandler<1>::last_face (const unsigned int) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::last_active_face () const {
@@ -196,7 +182,6 @@ DoFHandler<1>::last_active_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::last_active_face (const unsigned int) const {
@@ -205,8 +190,6 @@ DoFHandler<1>::last_active_face (const unsigned int) const {
 };
 
 
-
-
 template <>
 DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::begin_raw_quad (const unsigned int) const {
@@ -215,7 +198,6 @@ DoFHandler<1>::begin_raw_quad (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::quad_iterator
 DoFHandler<1>::begin_quad (const unsigned int) const {
@@ -224,7 +206,6 @@ DoFHandler<1>::begin_quad (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::begin_active_quad (const unsigned int) const {
@@ -233,7 +214,6 @@ DoFHandler<1>::begin_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::end_quad () const {
@@ -242,7 +222,6 @@ DoFHandler<1>::end_quad () const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::last_raw_quad (const unsigned int) const {
@@ -259,7 +238,6 @@ DoFHandler<1>::last_quad (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::last_active_quad (const unsigned int) const {
@@ -268,7 +246,6 @@ DoFHandler<1>::last_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::last_raw_quad () const {
@@ -277,7 +254,6 @@ DoFHandler<1>::last_raw_quad () const {
 };
 
 
-
 template <>
 DoFHandler<1>::quad_iterator
 DoFHandler<1>::last_quad () const {
@@ -286,7 +262,6 @@ DoFHandler<1>::last_quad () const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::last_active_quad () const {
@@ -295,7 +270,6 @@ DoFHandler<1>::last_active_quad () const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::begin_raw_hex (const unsigned int) const {
@@ -304,7 +278,6 @@ DoFHandler<1>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::hex_iterator
 DoFHandler<1>::begin_hex (const unsigned int) const {
@@ -313,7 +286,6 @@ DoFHandler<1>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::begin_active_hex (const unsigned int) const {
@@ -322,7 +294,6 @@ DoFHandler<1>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::end_hex () const {
@@ -331,7 +302,6 @@ DoFHandler<1>::end_hex () const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::last_raw_hex (const unsigned int) const {
@@ -340,7 +310,6 @@ DoFHandler<1>::last_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::last_raw_hex () const {
@@ -349,7 +318,6 @@ DoFHandler<1>::last_raw_hex () const {
 };
 
 
-
 template <>
 DoFHandler<1>::hex_iterator
 DoFHandler<1>::last_hex (const unsigned int) const {
@@ -358,7 +326,6 @@ DoFHandler<1>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::hex_iterator
 DoFHandler<1>::last_hex () const {
@@ -367,7 +334,6 @@ DoFHandler<1>::last_hex () const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::last_active_hex (const unsigned int) const {
@@ -376,7 +342,6 @@ DoFHandler<1>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::last_active_hex () const {
@@ -396,7 +361,6 @@ DoFHandler<2>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::begin (const unsigned int level) const {
@@ -404,7 +368,6 @@ DoFHandler<2>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::begin_active (const unsigned int level) const {
@@ -412,7 +375,6 @@ DoFHandler<2>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::end () const {
@@ -420,7 +382,6 @@ DoFHandler<2>::end () const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::last_raw () const {
@@ -428,7 +389,6 @@ DoFHandler<2>::last_raw () const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::last_raw (const unsigned int level) const {
@@ -436,7 +396,6 @@ DoFHandler<2>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::last () const {
@@ -444,7 +403,6 @@ DoFHandler<2>::last () const {
 };
 
 
-
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::last (const unsigned int level) const {
@@ -452,7 +410,6 @@ DoFHandler<2>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::last_active () const {
@@ -460,7 +417,6 @@ DoFHandler<2>::last_active () const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::last_active (const unsigned int level) const {
@@ -475,7 +431,6 @@ DoFHandler<2>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::begin_face (const unsigned int level) const {
@@ -483,7 +438,6 @@ DoFHandler<2>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::begin_active_face (const unsigned int level) const {
@@ -491,7 +445,6 @@ DoFHandler<2>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::end_face () const {
@@ -499,7 +452,6 @@ DoFHandler<2>::end_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::last_raw_face () const {
@@ -507,7 +459,6 @@ DoFHandler<2>::last_raw_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::last_raw_face (const unsigned int level) const {
@@ -515,7 +466,6 @@ DoFHandler<2>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::last_face () const {
@@ -523,7 +473,6 @@ DoFHandler<2>::last_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::last_face (const unsigned int level) const {
@@ -531,7 +480,6 @@ DoFHandler<2>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::last_active_face () const {
@@ -539,7 +487,6 @@ DoFHandler<2>::last_active_face () const {
 };
 
 
-
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::last_active_face (const unsigned int level) const {
@@ -547,7 +494,6 @@ DoFHandler<2>::last_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::begin_raw_hex (const unsigned int) const {
@@ -556,7 +502,6 @@ DoFHandler<2>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::hex_iterator
 DoFHandler<2>::begin_hex (const unsigned int) const {
@@ -565,7 +510,6 @@ DoFHandler<2>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::begin_active_hex (const unsigned int) const {
@@ -574,7 +518,6 @@ DoFHandler<2>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::end_hex () const {
@@ -583,7 +526,6 @@ DoFHandler<2>::end_hex () const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::last_raw_hex (const unsigned int) const {
@@ -592,7 +534,6 @@ DoFHandler<2>::last_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::last_raw_hex () const {
@@ -601,7 +542,6 @@ DoFHandler<2>::last_raw_hex () const {
 };
 
 
-
 template <>
 DoFHandler<2>::hex_iterator
 DoFHandler<2>::last_hex (const unsigned int) const {
@@ -610,7 +550,6 @@ DoFHandler<2>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::hex_iterator
 DoFHandler<2>::last_hex () const {
@@ -619,7 +558,6 @@ DoFHandler<2>::last_hex () const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::last_active_hex (const unsigned int) const {
@@ -628,7 +566,6 @@ DoFHandler<2>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::last_active_hex () const {
@@ -640,9 +577,6 @@ DoFHandler<2>::last_active_hex () const {
 #endif
 
 
-
-
-
 #if deal_II_dimension == 3
 
 template <>
@@ -652,7 +586,6 @@ DoFHandler<3>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::begin (const unsigned int level) const {
@@ -660,7 +593,6 @@ DoFHandler<3>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::begin_active (const unsigned int level) const {
@@ -668,7 +600,6 @@ DoFHandler<3>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::end () const {
@@ -676,7 +607,6 @@ DoFHandler<3>::end () const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::last_raw () const {
@@ -684,7 +614,6 @@ DoFHandler<3>::last_raw () const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::last_raw (const unsigned int level) const {
@@ -692,7 +621,6 @@ DoFHandler<3>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::last () const {
@@ -700,7 +628,6 @@ DoFHandler<3>::last () const {
 };
 
 
-
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::last (const unsigned int level) const {
@@ -708,7 +635,6 @@ DoFHandler<3>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::last_active () const {
@@ -716,7 +642,6 @@ DoFHandler<3>::last_active () const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::last_active (const unsigned int level) const {
@@ -724,11 +649,6 @@ DoFHandler<3>::last_active (const unsigned int level) const {
 };
 
 
-
-
-
-
-
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::begin_raw_face (const unsigned int level) const {
@@ -736,7 +656,6 @@ DoFHandler<3>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::begin_face (const unsigned int level) const {
@@ -744,7 +663,6 @@ DoFHandler<3>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::begin_active_face (const unsigned int level) const {
@@ -752,7 +670,6 @@ DoFHandler<3>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::end_face () const {
@@ -760,7 +677,6 @@ DoFHandler<3>::end_face () const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::last_raw_face () const {
@@ -768,7 +684,6 @@ DoFHandler<3>::last_raw_face () const {
 };
 
 
-
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::last_raw_face (const unsigned int level) const {
@@ -776,7 +691,6 @@ DoFHandler<3>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::last_face () const {
@@ -784,7 +698,6 @@ DoFHandler<3>::last_face () const {
 };
 
 
-
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::last_face (const unsigned int level) const {
@@ -792,7 +705,6 @@ DoFHandler<3>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::last_active_face () const {
@@ -800,7 +712,6 @@ DoFHandler<3>::last_active_face () const {
 };
 
 
-
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::last_active_face (const unsigned int level) const {
@@ -811,7 +722,6 @@ DoFHandler<3>::last_active_face (const unsigned int level) const {
 #endif
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::begin_raw_line (const unsigned int level) const {
@@ -822,7 +732,6 @@ DoFHandler<dim>::begin_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::line_iterator
 DoFHandler<dim>::begin_line (const unsigned int level) const {
@@ -833,7 +742,6 @@ DoFHandler<dim>::begin_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_line_iterator
 DoFHandler<dim>::begin_active_line (const unsigned int level) const {
@@ -844,7 +752,6 @@ DoFHandler<dim>::begin_active_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
@@ -855,7 +762,6 @@ DoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::quad_iterator
 DoFHandler<dim>::begin_quad (const unsigned int level) const {
@@ -866,7 +772,6 @@ DoFHandler<dim>::begin_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_quad_iterator
 DoFHandler<dim>::begin_active_quad (const unsigned int level) const {
@@ -877,8 +782,6 @@ DoFHandler<dim>::begin_active_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
@@ -889,7 +792,6 @@ DoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::hex_iterator
 DoFHandler<dim>::begin_hex (const unsigned int level) const {
@@ -900,7 +802,6 @@ DoFHandler<dim>::begin_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_hex_iterator
 DoFHandler<dim>::begin_active_hex (const unsigned int level) const {
@@ -911,7 +812,6 @@ DoFHandler<dim>::begin_active_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::end_line () const {
@@ -919,7 +819,6 @@ DoFHandler<dim>::end_line () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::end_quad () const {
@@ -927,7 +826,6 @@ DoFHandler<dim>::end_quad () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::end_hex () const {
@@ -935,7 +833,6 @@ DoFHandler<dim>::end_hex () const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::raw_cell_iterator
 DoFHandler<dim>::end_raw (const unsigned int level) const {
@@ -945,7 +842,6 @@ DoFHandler<dim>::end_raw (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::cell_iterator
 DoFHandler<dim>::end (const unsigned int level) const {
@@ -955,7 +851,6 @@ DoFHandler<dim>::end (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::active_cell_iterator
 DoFHandler<dim>::end_active (const unsigned int level) const {
@@ -965,7 +860,6 @@ DoFHandler<dim>::end_active (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::raw_face_iterator
 DoFHandler<dim>::end_raw_face (const unsigned int level) const {
@@ -975,7 +869,6 @@ DoFHandler<dim>::end_raw_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::face_iterator
 DoFHandler<dim>::end_face (const unsigned int level) const {
@@ -985,7 +878,6 @@ DoFHandler<dim>::end_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::active_face_iterator
 DoFHandler<dim>::end_active_face (const unsigned int level) const {
@@ -995,7 +887,6 @@ DoFHandler<dim>::end_active_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::raw_line_iterator
 DoFHandler<dim>::end_raw_line (const unsigned int level) const {
@@ -1005,7 +896,6 @@ DoFHandler<dim>::end_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::line_iterator
 DoFHandler<dim>::end_line (const unsigned int level) const {
@@ -1015,7 +905,6 @@ DoFHandler<dim>::end_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::active_line_iterator
 DoFHandler<dim>::end_active_line (const unsigned int level) const {
@@ -1025,8 +914,6 @@ DoFHandler<dim>::end_active_line (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFDimensionInfo<dim>::raw_quad_iterator
 DoFHandler<dim>::end_raw_quad (const unsigned int level) const {
@@ -1036,7 +923,6 @@ DoFHandler<dim>::end_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::quad_iterator
 DoFHandler<dim>::end_quad (const unsigned int level) const {
@@ -1046,7 +932,6 @@ DoFHandler<dim>::end_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::active_quad_iterator
 DoFHandler<dim>::end_active_quad (const unsigned int level) const {
@@ -1056,7 +941,6 @@ DoFHandler<dim>::end_active_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::raw_hex_iterator
 DoFHandler<dim>::end_raw_hex (const unsigned int level) const {
@@ -1066,7 +950,6 @@ DoFHandler<dim>::end_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::hex_iterator
 DoFHandler<dim>::end_hex (const unsigned int level) const {
@@ -1076,7 +959,6 @@ DoFHandler<dim>::end_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFDimensionInfo<dim>::active_hex_iterator
 DoFHandler<dim>::end_active_hex (const unsigned int level) const {
@@ -1086,7 +968,6 @@ DoFHandler<dim>::end_active_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::last_raw_line (const unsigned int level) const {
@@ -1097,7 +978,6 @@ DoFHandler<dim>::last_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::line_iterator
 DoFHandler<dim>::last_line (const unsigned int level) const {
@@ -1108,7 +988,6 @@ DoFHandler<dim>::last_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_line_iterator
 DoFHandler<dim>::last_active_line (const unsigned int level) const {
@@ -1119,7 +998,6 @@ DoFHandler<dim>::last_active_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::last_raw_quad (const unsigned int level) const {
@@ -1130,8 +1008,6 @@ DoFHandler<dim>::last_raw_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFHandler<dim>::quad_iterator
 DoFHandler<dim>::last_quad (const unsigned int level) const {
@@ -1142,8 +1018,6 @@ DoFHandler<dim>::last_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFHandler<dim>::active_quad_iterator
 DoFHandler<dim>::last_active_quad (const unsigned int level) const {
@@ -1154,7 +1028,6 @@ DoFHandler<dim>::last_active_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::last_raw_hex (const unsigned int level) const {
@@ -1165,8 +1038,6 @@ DoFHandler<dim>::last_raw_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFHandler<dim>::hex_iterator
 DoFHandler<dim>::last_hex (const unsigned int level) const {
@@ -1177,8 +1048,6 @@ DoFHandler<dim>::last_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename DoFHandler<dim>::active_hex_iterator
 DoFHandler<dim>::last_active_hex (const unsigned int level) const {
@@ -1189,7 +1058,6 @@ DoFHandler<dim>::last_active_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::last_raw_line () const {
@@ -1197,7 +1065,6 @@ DoFHandler<dim>::last_raw_line () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::last_raw_quad () const {
@@ -1205,7 +1072,6 @@ DoFHandler<dim>::last_raw_quad () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::last_raw_hex () const {
@@ -1213,7 +1079,6 @@ DoFHandler<dim>::last_raw_hex () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::line_iterator
 DoFHandler<dim>::last_line () const {
@@ -1221,7 +1086,6 @@ DoFHandler<dim>::last_line () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::quad_iterator
 DoFHandler<dim>::last_quad () const {
@@ -1229,7 +1093,6 @@ DoFHandler<dim>::last_quad () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::hex_iterator
 DoFHandler<dim>::last_hex () const {
@@ -1237,7 +1100,6 @@ DoFHandler<dim>::last_hex () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_line_iterator
 DoFHandler<dim>::last_active_line () const {
@@ -1245,7 +1107,6 @@ DoFHandler<dim>::last_active_line () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_quad_iterator
 DoFHandler<dim>::last_active_quad () const {
@@ -1253,7 +1114,6 @@ DoFHandler<dim>::last_active_quad () const {
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::active_hex_iterator
 DoFHandler<dim>::last_active_hex () const {
@@ -1261,18 +1121,9 @@ DoFHandler<dim>::last_active_hex () const {
 };
 
 
-
-
-
-
 //------------------------------------------------------------------
 
 
-
-
-
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1283,7 +1134,6 @@ unsigned int DoFHandler<1>::n_boundary_dofs () const {
 };
 
 
-
 template <>
 unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &) const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1294,9 +1144,6 @@ unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &) const {
 #endif
 
 
-
-
-
 template <int dim>
 unsigned int DoFHandler<dim>::n_boundary_dofs () const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1318,7 +1165,6 @@ unsigned int DoFHandler<dim>::n_boundary_dofs () const {
 };    
 
 
-
 template <int dim>
 unsigned int DoFHandler<dim>::n_boundary_dofs (const FunctionMap &boundary_indicators) const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1343,14 +1189,12 @@ unsigned int DoFHandler<dim>::n_boundary_dofs (const FunctionMap &boundary_indic
 };    
 
 
-
 template <int dim>
 const Triangulation<dim> & DoFHandler<dim>::get_tria () const {
   return *tria;
 };
 
 
-
 template <int dim>
 void DoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &ff,
                                       const unsigned int        offset)
@@ -1376,7 +1220,6 @@ void DoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &ff,
 };
 
 
-
 template <int dim>
 void DoFHandler<dim>::clear () {
                                   // release lock to old fe
@@ -1387,8 +1230,6 @@ void DoFHandler<dim>::clear () {
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1472,15 +1313,15 @@ unsigned int DoFHandler<2>::distribute_dofs_on_cell (active_cell_iterator &cell,
          for (unsigned int d=0; d<selected_fe->dofs_per_line; ++d)
            line->set_dof_index (d, next_free_dof++);       
       };
-  
 
-                                      // dofs of quad
+
+// dofs of quad
   if (selected_fe->dofs_per_quad > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_quad; ++d)
       cell->set_dof_index (d, next_free_dof++);
 
-  
-                                  // note that this cell has been processed
+
+// note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1489,7 +1330,6 @@ unsigned int DoFHandler<2>::distribute_dofs_on_cell (active_cell_iterator &cell,
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1536,13 +1376,13 @@ unsigned int DoFHandler<3>::distribute_dofs_on_cell (active_cell_iterator &cell,
       };
 
 
-                                      // dofs of hex
+// dofs of hex
   if (selected_fe->dofs_per_hex > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_hex; ++d)
       cell->set_dof_index (d, next_free_dof++);
 
-  
-                                  // note that this cell has been processed
+
+// note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1551,7 +1391,6 @@ unsigned int DoFHandler<3>::distribute_dofs_on_cell (active_cell_iterator &cell,
 #endif
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1709,8 +1548,6 @@ void DoFHandler<3>::renumber_dofs (const vector<unsigned int> &new_numbers) {
 #endif
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1720,7 +1557,6 @@ unsigned int DoFHandler<1>::max_couplings_between_dofs () const {
 };
 
 
-
 template <>
 unsigned int DoFHandler<1>::max_couplings_between_boundary_dofs () const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1731,7 +1567,6 @@ unsigned int DoFHandler<1>::max_couplings_between_boundary_dofs () const {
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -1788,7 +1623,6 @@ unsigned int DoFHandler<2>::max_couplings_between_dofs () const {
 };
 
 
-
 template <>
 unsigned int DoFHandler<2>::max_couplings_between_boundary_dofs () const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1821,13 +1655,12 @@ unsigned int DoFHandler<3>::max_couplings_between_dofs () const {
            9*4*7*3*selected_fe->dofs_per_quad +
            27*selected_fe->dofs_per_hex);
 
-  
-  Assert (false, ExcNotImplemented());
+
+Assert (false, ExcNotImplemented());
   return 0;
 };
 
 
-
 template <>
 unsigned int DoFHandler<3>::max_couplings_between_boundary_dofs () const {
   Assert (selected_fe != 0, ExcNoFESelected());
@@ -1850,13 +1683,9 @@ unsigned int DoFHandler<3>::max_couplings_between_boundary_dofs () const {
 };
 
 
-
 #endif
 
 
-
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1866,7 +1695,6 @@ void DoFHandler<1>::map_dof_to_boundary_indices (vector<unsigned int> &) const {
 };
 
 
-
 template <>
 void DoFHandler<1>::map_dof_to_boundary_indices (const FunctionMap &,
                                                 vector<unsigned int> &) const {
@@ -1877,7 +1705,6 @@ void DoFHandler<1>::map_dof_to_boundary_indices (const FunctionMap &,
 #endif
 
 
-
 template <int dim>
 void DoFHandler<dim>::map_dof_to_boundary_indices (vector<unsigned int> &mapping) const
 {
@@ -1906,7 +1733,6 @@ void DoFHandler<dim>::map_dof_to_boundary_indices (vector<unsigned int> &mapping
 };
 
 
-
 template <int dim>
 void DoFHandler<dim>::map_dof_to_boundary_indices (const FunctionMap    &boundary_indicators,
                                                   vector<unsigned int> &mapping) const
@@ -1943,7 +1769,6 @@ void DoFHandler<dim>::map_dof_to_boundary_indices (const FunctionMap    &boundar
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -2049,7 +1874,6 @@ void DoFHandler<dim>::clear_space () {
 };
 
 
-
 /*-------------- Explicit Instantiations -------------------------------*/
 template class DoFHandler<deal_II_dimension>;
 
index 6394aa15e2cb76359b471a947b6fa6572dde2c0e..c93958442314f94248e11b5a25c47829a8fc5497 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  dof_renumbering.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_renumbering.cc  ---------------------------
+
 
 #include <lac/sparsity_pattern.h>
 #include <dofs/dof_accessor.h>
@@ -16,7 +28,6 @@
 #include <algorithm>
 
 
-
 template <int dim>
 void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>            &dof_handler,
                                    const bool                  reversed_numbering,
@@ -100,9 +111,9 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>            &dof_handler,
                                       // initialize the first dof
       last_round_dofs.push_back (starting_point);
     };
-  
 
-                                  // store next free dof index
+
+// store next free dof index
   unsigned int next_free_number = 0;
 
                                   // enumerate the first round dofs
@@ -150,9 +161,9 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>            &dof_handler,
       if (all_dofs_renumbered)
                                         // end loop if possible
        continue;
-      
 
-                                      // store for each coordination
+
+// store for each coordination
                                       // number the dofs with these
                                       // coordination number
       multimap<unsigned int, int> dofs_by_coordination;
@@ -207,8 +218,6 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>            &dof_handler,
 };
 
 
-
-
 template <int dim>
 void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
                                    const unsigned int          level,
@@ -265,9 +274,9 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
                                       // initialize the first dof
       last_round_dofs.push_back (starting_point);
     };
-  
 
-                                  // store next free dof index
+
+// store next free dof index
   unsigned int next_free_number = 0;
 
                                   // enumerate the first round dofs
@@ -315,9 +324,9 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
       if (all_dofs_renumbered)
                                         // end loop if possible
        continue;
-      
 
-                                      // store for each coordination
+
+// store for each coordination
                                       // number the dofs with these
                                       // coordination number
       multimap<unsigned int, int> dofs_by_coordination;
@@ -373,7 +382,6 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
 };
 
 
-
 template <int dim>
 void DoFRenumbering::component_wise (DoFHandler<dim>            &dof_handler,
                                     const vector<unsigned int> &component_order_arg)
@@ -468,10 +476,6 @@ void DoFRenumbering::component_wise (DoFHandler<dim>            &dof_handler,
   dof_handler.renumber_dofs (new_indices);
 };
 
-  
-  
-
-
 
 // explicit instantiations
 template
index 6752441bfeba3dc352c359f192b8de69a05acb71..7f17cf6d35c91308ffc95f55f0ff7778ec59c89b 100644 (file)
@@ -1,4 +1,15 @@
-// $Id$
+//----------------------------  dof_tools.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_tools.cc  ---------------------------
 
 
 #include <grid/tria.h>
@@ -74,9 +85,9 @@ DoFTools::make_sparsity_pattern (const DoFHandler<dim>       &dof,
       dof_mask[i][j] = mask
                       [dof.get_fe().system_to_component_index(i).first]
                       [dof.get_fe().system_to_component_index(j).first];
-  
-  
-  vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
+
+
+vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
   DoFHandler<dim>::active_cell_iterator cell = dof.begin_active(),
                       endc = dof.end();
   for (; cell!=endc; ++cell) 
@@ -103,7 +114,6 @@ void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<1>&,
 };
 
 
-
 template <>
 void
 DoFTools::make_boundary_sparsity_pattern (const DoFHandler<1>&,
@@ -117,7 +127,6 @@ DoFTools::make_boundary_sparsity_pattern (const DoFHandler<1>&,
 #endif
 
 
-
 template <int dim>
 void
 DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
@@ -159,7 +168,6 @@ DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
 };
 
 
-
 template <int dim>
 void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
                                               const DoFHandler<dim>::FunctionMap  &boundary_indicators,
@@ -213,8 +221,6 @@ void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
 };
 
 
-
-
 //TODO: Check this function for potential of optimization. (G)
 
 template<int dim>
@@ -269,7 +275,6 @@ DoFTools::make_flux_sparsity_pattern (const DoFHandler<dim> &dof,
 }
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -282,7 +287,6 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<1> &,
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -311,11 +315,9 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<2> &dof_handler,
     for (unsigned int face=0; face<GeometryInfo<dim>::faces_per_cell; ++face)
       if (cell->face(face)->has_children()) 
        cell->face(face)->set_user_flag();
-         
-  
 
-  
-                                  // loop over all lines; only on lines
+
+// loop over all lines; only on lines
                                   // there can be constraints.
   for (line = dof_handler.begin_line(); line != endl; ++line)
                                     // if dofs on this line are subject
@@ -376,7 +378,6 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<2> &dof_handler,
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -405,9 +406,9 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<3> &dof_handler,
     for (unsigned int face=0; face<GeometryInfo<dim>::faces_per_cell; ++face)
       if (cell->face(face)->has_children()) 
        cell->face(face)->set_user_flag();
-         
-  
-                                  // loop over all faces; only on faces
+
+
+// loop over all faces; only on faces
                                   // there can be constraints.
   for (face=dof_handler.begin_face(); face != endf; ++face)
                                     // if dofs on this line are subject
@@ -533,8 +534,6 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<3> &dof_handler,
 #endif
 
 
-
-
 template <int dim, typename Number>
 void DoFTools::distribute_cell_to_dof_vector (const DoFHandler<dim> &dof_handler,
                                              const Vector<Number>  &cell_data,
@@ -605,7 +604,6 @@ void DoFTools::distribute_cell_to_dof_vector (const DoFHandler<dim> &dof_handler
 };
 
 
-
 template<int dim>
 void
 DoFTools::extract_dofs(const DoFHandler<dim> &dof,
@@ -638,7 +636,6 @@ DoFTools::extract_dofs(const DoFHandler<dim> &dof,
 }
 
 
-
 template<int dim>
 void
 DoFTools::extract_level_dofs(const unsigned int       level,
@@ -671,7 +668,6 @@ DoFTools::extract_level_dofs(const unsigned int       level,
 }
 
 
-
 // explicit instantiations
 #if deal_II_dimension > 1
 template void
@@ -710,7 +706,6 @@ DoFTools::distribute_cell_to_dof_vector (const DoFHandler<deal_II_dimension> &do
                                         Vector<double>       &dof_data) const;
 
 
-
 template void DoFTools::extract_dofs(const DoFHandler<deal_II_dimension>& dof,
                                     const vector<bool>& local_select,
                                     vector<bool>& selected_dofs);
index 7fdbeb0efca3cfa6514d24d1971e4c183bd69ef4..ccdd4e4ffc5973011e60f9262c5f063391380f4c 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe.cc  ---------------------------
 
 
 #include <fe/fe.h>
@@ -10,7 +20,6 @@
 #include <grid/tria_boundary.h>
 
 
-
 /*------------------------------- FiniteElementData ----------------------*/
 
 template <int dim>
@@ -20,8 +29,6 @@ FiniteElementData<dim>::FiniteElementData ()
 };
 
 
-
-
 template <int dim>
 FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
                                           const unsigned int dofs_per_line,
@@ -57,7 +64,6 @@ FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
 };
 
 
-
 template <int dim>
 FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
                                           const unsigned int dofs_per_line,
@@ -88,7 +94,6 @@ FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
 };
 
 
-
 template <int dim>
 FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
                                           const unsigned int dofs_per_line,
@@ -117,14 +122,11 @@ FiniteElementData<dim>::FiniteElementData (const unsigned int dofs_per_vertex,
 };
 
 
-
 template <int dim>
 FiniteElementData<dim>::~FiniteElementData ()
 {};
 
 
-
-
 template<int dim>
 bool FiniteElementData<dim>::operator== (const FiniteElementData<dim> &f) const
 {
@@ -137,11 +139,9 @@ bool FiniteElementData<dim>::operator== (const FiniteElementData<dim> &f) const
 };
 
 
-
 /*------------------------------- FiniteElementBase ----------------------*/
 
 
-
 template <int dim>
 FiniteElementBase<dim>::FiniteElementBase (const FiniteElementData<dim> &fe_data,
                                           const vector<bool> &restriction_is_additive_flags) :
@@ -204,7 +204,6 @@ FiniteElementBase<dim>::FiniteElementBase (const FiniteElementData<dim> &fe_data
 };
 
 
-
 template <int dim>
 const FullMatrix<double> &
 FiniteElementBase<dim>::restrict (const unsigned int child) const
@@ -215,7 +214,6 @@ FiniteElementBase<dim>::restrict (const unsigned int child) const
 };
 
 
-
 template <int dim>
 const FullMatrix<double> &
 FiniteElementBase<dim>::prolongate (const unsigned int child) const
@@ -226,7 +224,6 @@ FiniteElementBase<dim>::prolongate (const unsigned int child) const
 };
 
 
-
 template <int dim>
 const FullMatrix<double> &
 FiniteElementBase<dim>::constraints () const
@@ -240,7 +237,6 @@ FiniteElementBase<dim>::constraints () const
 };
 
 
-
 template <int dim>
 bool FiniteElementBase<dim>::operator == (const FiniteElementBase<dim> &f) const
 {
@@ -250,7 +246,6 @@ bool FiniteElementBase<dim>::operator == (const FiniteElementBase<dim> &f) const
 };
 
 
-
 /*------------------------------- FiniteElement ----------------------*/
 
 
@@ -290,7 +285,7 @@ void FiniteElement<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
 
-                                  // local mesh width
+// local mesh width
   const double h=(cell->vertex(1)(0) - cell->vertex(0)(0));
 
   for (unsigned int i=0; i<q_points.size(); ++i) 
@@ -318,7 +313,6 @@ void FiniteElement<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FiniteElement<1>::fill_fe_face_values (const DoFHandler<1>::cell_iterator &,
                                            const unsigned int       ,
@@ -364,7 +358,6 @@ void FiniteElement<1>::fill_fe_subface_values (const DoFHandler<1>::cell_iterato
 };
 
 
-
 template <>
 void FiniteElement<1>::get_unit_support_points (vector<Point<1> > &support_points) const {
   Assert (support_points.size() == dofs_per_cell,
@@ -386,7 +379,6 @@ void FiniteElement<1>::get_unit_support_points (vector<Point<1> > &support_point
 };
 
 
-
 template <>
 void FiniteElement<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
                                           vector<Point<1> > &support_points) const {
@@ -413,7 +405,6 @@ void FiniteElement<1>::get_support_points (const DoFHandler<1>::cell_iterator &c
 #endif
 
 
-
 template <int dim>
 void FiniteElement<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &,
                                         const vector<Point<dim> > &,
@@ -431,7 +422,6 @@ void FiniteElement<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &,
 };
 
 
-
 template <int dim>
 void FiniteElement<dim>::fill_fe_face_values (const DoFHandler<dim>::cell_iterator &cell,
                                              const unsigned int           face_no,
@@ -482,8 +472,6 @@ void FiniteElement<dim>::fill_fe_face_values (const DoFHandler<dim>::cell_iterat
 };
 
 
-
-
 template <int dim>
 void FiniteElement<dim>::fill_fe_subface_values (const DoFHandler<dim>::cell_iterator &cell,
                                                 const unsigned int           face_no,
@@ -527,7 +515,6 @@ void FiniteElement<dim>::fill_fe_subface_values (const DoFHandler<dim>::cell_ite
 };
 
 
-
 template <int dim>
 void
 FiniteElement<dim>::get_unit_support_points (vector<Point<dim> > &) const
@@ -536,7 +523,6 @@ FiniteElement<dim>::get_unit_support_points (vector<Point<dim> > &) const
 };
 
 
-
 template <int dim>
 void
 FiniteElement<dim>::get_support_points (const DoFHandler<dim>::cell_iterator &,
@@ -568,4 +554,3 @@ template class FiniteElementBase<deal_II_dimension>;
 template class FiniteElement<deal_II_dimension>;
 
 
-
index 9bedd8b522dd109a32e19f07131987f253706b2b..b16cb3bfc988557848727992bcbf3a6e228156c4 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_lib.criss_cross.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.criss_cross.cc  ---------------------------
 
 
 #include <fe/fe_lib.criss_cross.h>
@@ -10,7 +20,6 @@
 #include <cmath>
 
 
-
 /*-----------------------------------2d------------------------------------
   Maple script to automate some of the error-prone computations on
   this strange sort of element.
     od:
   od:
 
-  
-  # these are the basis functions differentiated with respect to
+
+# these are the basis functions differentiated with respect to
   # xi and eta. we need them for the computation of the jacobi
   # matrix, since we can't just differentiate a function.
   phi_xi[0] := proc(x,y) if(y<1-x) then -1;  else 0; fi; end:
           end:
 
 
-  # Now for the mass matrix: we divide the entire cell into four
+# Now for the mass matrix: we divide the entire cell into four
   # sectors:
   #
   # *-------*
 -----------------------------------------------------------------------------*/
 
 
-
-
-
-
-
 #if deal_II_dimension == 1
 
 
@@ -317,7 +321,6 @@ FECrissCross<1>::FECrissCross () :
 };
 
 
-
 template <>
 double FECrissCross<1>::shape_value (const unsigned int, const Point<1> &) const {
   Assert (false, ExcNotUseful());
@@ -325,7 +328,6 @@ double FECrissCross<1>::shape_value (const unsigned int, const Point<1> &) const
 };
 
 
-
 template <>
 Tensor<1,1> FECrissCross<1>::shape_grad (const unsigned int, const Point<1> &) const {
   Assert (false, ExcNotUseful());
@@ -333,7 +335,6 @@ Tensor<1,1> FECrissCross<1>::shape_grad (const unsigned int, const Point<1> &) c
 };
 
 
-
 template <>
 Tensor<2,1> FECrissCross<1>::shape_grad_grad (const unsigned int, const Point<1> &) const {
   Assert (false, ExcNotUseful());
@@ -341,14 +342,12 @@ Tensor<2,1> FECrissCross<1>::shape_grad_grad (const unsigned int, const Point<1>
 };
 
 
-
 template <>
 void FECrissCross<1>::get_unit_support_points (vector<Point<1> >&) const {
   Assert (false, ExcNotUseful());
 };
 
 
-
 template <>
 void FECrissCross<1>::get_support_points (const DoFHandler<1>::cell_iterator &,
                                          vector<Point<1> > &) const {
@@ -356,7 +355,6 @@ void FECrissCross<1>::get_support_points (const DoFHandler<1>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
                                               vector<Point<1> > &) const {
@@ -364,7 +362,6 @@ void FECrissCross<1>::get_face_support_points (const DoFHandler<1>::face_iterato
 };
 
 
-
 template <>
 void FECrissCross<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &,
                                             FullMatrix<double> &) const {
@@ -372,7 +369,6 @@ void FECrissCross<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator
 };
 
 
-
 template <>
 double  FECrissCross<1>::shape_value_transform (const unsigned int,
                                                const Point<1> &) const {
@@ -381,7 +377,6 @@ double  FECrissCross<1>::shape_value_transform (const unsigned int,
 };
 
 
-
 template <>
 Tensor<1,1> FECrissCross<1>::shape_grad_transform (const unsigned int,
                                                   const Point<1> &) const {
@@ -390,7 +385,6 @@ Tensor<1,1> FECrissCross<1>::shape_grad_transform (const unsigned int,
 };
 
 
-
 template <>
 void FECrissCross<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
                                          const vector<Point<0> > &,
@@ -399,7 +393,6 @@ void FECrissCross<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator &,
                                             const unsigned int,
@@ -409,7 +402,6 @@ void FECrissCross<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator
 };
 
 
-
 template <>
 void FECrissCross<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                          const unsigned int,
@@ -419,7 +411,6 @@ void FECrissCross<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                          const unsigned int,
@@ -430,7 +421,6 @@ void FECrissCross<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &,
                                       const vector<Point<1> > &,
@@ -450,10 +440,6 @@ void FECrissCross<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &,
 #endif
 
 
-
-
-
-
 #if deal_II_dimension == 2
 
 
@@ -509,8 +495,6 @@ FECrissCross<2>::FECrissCross () :
 };
 
 
-
-
 template <>
 inline
 double FECrissCross<2>::shape_value (const unsigned int i,
@@ -539,7 +523,6 @@ double FECrissCross<2>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,2> FECrissCross<2>::shape_grad (const unsigned int i, const Point<2> &p) const
@@ -582,7 +565,6 @@ FECrissCross<2>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FECrissCross<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   Assert(unit_points.size()==dofs_per_cell,
@@ -596,7 +578,6 @@ void FECrissCross<2>::get_unit_support_points (vector<Point<2> > &unit_points) c
 };
 
 
-
 template <>
 void FECrissCross<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
                                          vector<Point<2> > &support_points) const {
@@ -633,7 +614,6 @@ void FECrissCross<2>::get_support_points (const DoFHandler<2>::cell_iterator &ce
 };
 
 
-
 template <>
 void FECrissCross<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
                                               vector<Point<2> > &support_points) const {
@@ -649,7 +629,6 @@ void FECrissCross<2>::get_face_support_points (const DoFHandler<2>::face_iterato
 };
 
 
-
 template <>
 void FECrissCross<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
                                             FullMatrix<double> &mass_matrix) const {
@@ -791,7 +770,6 @@ void FECrissCross<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator
 };
 
 
-
 template <>
 inline
 double FECrissCross<2>::shape_value_transform (const unsigned int i,
@@ -801,7 +779,6 @@ double FECrissCross<2>::shape_value_transform (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,2> FECrissCross<2>::shape_grad_transform (const unsigned int i,
                                                   const Point<2> &p) const {
@@ -810,7 +787,6 @@ Tensor<1,2> FECrissCross<2>::shape_grad_transform (const unsigned int i,
 };
 
 
-
 template <>
 void FECrissCross<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &face,
                                          const vector<Point<1> > &unit_points,
@@ -831,7 +807,6 @@ void FECrissCross<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &fa
 };
 
 
-
 template <>
 void FECrissCross<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator &face,
                                             const unsigned int,
@@ -855,7 +830,6 @@ void FECrissCross<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator
 };
 
 
-
 template <>
 void FECrissCross<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                          const unsigned int       face_no,
@@ -886,7 +860,6 @@ void FECrissCross<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &ce
 };
 
 
-
 template <>
 void FECrissCross<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                          const unsigned int       face_no,
@@ -923,7 +896,6 @@ void FECrissCross<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &ce
 };
 
 
-
 template <int dim>
 void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
                                        const vector<Point<dim> >            &unit_points,
@@ -944,8 +916,8 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
   Assert (support_points.size() == dofs_per_cell,
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
-  
-  unsigned int n_points=unit_points.size();
+
+unsigned int n_points=unit_points.size();
 
                                   // we need the support points in any
                                   // way, wanted or not by the user
@@ -970,7 +942,7 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
        for (unsigned int l=0; l<n_points; ++l) 
          q_points[l] += support_points[j] * shape_values_transform(j, l);
     };
-  
+
 
 /* jacobi matrices: compute d(x)/d(xi) and invert this
    Let M(l) be the inverse of J at the quadrature point l, then
@@ -1055,7 +1027,7 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
       };
 
 
-  if (compute_jacobians_grad)
+if (compute_jacobians_grad)
     switch (dim) 
       {
        case 1:
@@ -1144,7 +1116,6 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 // provide dummy implementations of the functions above. the reason is
@@ -1161,7 +1132,6 @@ FECrissCross<3>::FECrissCross () :
 };
 
 
-
 template <>
 double
 FECrissCross<3>::shape_value (const unsigned int,
@@ -1172,7 +1142,6 @@ FECrissCross<3>::shape_value (const unsigned int,
 };
 
 
-
 template <>
 Tensor<1,3>
 FECrissCross<3>::shape_grad (const unsigned int,
@@ -1183,7 +1152,6 @@ FECrissCross<3>::shape_grad (const unsigned int,
 };
 
 
-
 template <>
 Tensor<2,3>
 FECrissCross<3>::shape_grad_grad (const unsigned int,
@@ -1194,7 +1162,6 @@ FECrissCross<3>::shape_grad_grad (const unsigned int,
 };
 
 
-
 template <>
 void
 FECrissCross<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
@@ -1204,7 +1171,6 @@ FECrissCross<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<3>::get_unit_support_points (vector<Point<3> > &) const
 {
@@ -1212,7 +1178,6 @@ void FECrissCross<3>::get_unit_support_points (vector<Point<3> > &) const
 };
 
 
-
 template <>
 void FECrissCross<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
                                  vector<Point<3> >  &) const
@@ -1221,7 +1186,6 @@ void FECrissCross<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<3>::get_face_support_points (const DoFHandler<3>::face_iterator &,
                                       vector<Point<3> >  &) const
@@ -1230,8 +1194,6 @@ void FECrissCross<3>::get_face_support_points (const DoFHandler<3>::face_iterato
 };
 
 
-
-
 template <>
 void FECrissCross<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &,
                                          const vector<Point<2> > &,
@@ -1240,7 +1202,6 @@ void FECrissCross<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<3>::get_subface_jacobians (const DoFHandler<3>::face_iterator &,
                                             const unsigned int,
@@ -1259,7 +1220,6 @@ void FECrissCross<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &,
                                          const unsigned int,
@@ -1270,7 +1230,6 @@ void FECrissCross<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FECrissCross<3>::fill_fe_values (const DoFHandler<3>::cell_iterator &,
                                      const vector<Point<3> > &,
@@ -1288,7 +1247,6 @@ void FECrissCross<3>::fill_fe_values (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 double FECrissCross<3>::shape_value_transform (const unsigned int,
                                               const Point<3> &) const
@@ -1298,7 +1256,6 @@ double FECrissCross<3>::shape_value_transform (const unsigned int,
 };
 
 
-
 template <>
 Tensor<1,3> FECrissCross<3>::shape_grad_transform (const unsigned int,
                                                   const Point<3> &) const
@@ -1311,8 +1268,6 @@ Tensor<1,3> FECrissCross<3>::shape_grad_transform (const unsigned int,
 #endif // deal_II_dimension == 3
 
 
-
-
 /*--------------------------- QCrissCross* ------------------------------------*/
 
 
@@ -1328,7 +1283,6 @@ QCrissCross1<1>::QCrissCross1 () :
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -1351,7 +1305,6 @@ QCrissCross1<2>::QCrissCross1 () :
 #endif
 
 
-
 // explicit instantiations
 
 template class FECrissCross<deal_II_dimension>;
index e0e49b07dcdb5430cd63b1154cae3bf545c25705..f57b895910e7c99f72a5fbaca98073846fcd6b7d 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_lib.cubic.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.cubic.cc  ---------------------------
 
 
 #include <fe/fe_lib.lagrange.h>
 #include <algorithm>
 
 
-
-
 // declare explicit specializations before use:
 template <> void FEQ3<deal_II_dimension>::initialize_matrices ();
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -27,7 +33,6 @@ FEQ3<1>::FEQ3 () :
 };
 
 
-
 template <>
 FEQ3<1>::FEQ3 (const int) :
                FEQ1Mapping<1> (0, 4, 0, 0, 1,
@@ -37,7 +42,6 @@ FEQ3<1>::FEQ3 (const int) :
 };
 
 
-
 template <>
 void FEQ3<1>::initialize_matrices () {
   
@@ -109,7 +113,6 @@ void FEQ3<1>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ3<1>::shape_value (const unsigned int i,
@@ -128,7 +131,6 @@ FEQ3<1>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,1>
 FEQ3<1>::shape_grad (const unsigned int i,
@@ -152,7 +154,6 @@ FEQ3<1>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,1>
 FEQ3<1>::shape_grad_grad (const unsigned int i,
@@ -174,14 +175,12 @@ FEQ3<1>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ3<1>::get_unit_support_points (vector<Point<1> > &unit_points) const {
   FiniteElement<1>::get_unit_support_points (unit_points);
 };
 
 
-
 template <>
 void FEQ3<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
                                  vector<Point<1> >  &support_points) const {
@@ -189,7 +188,6 @@ void FEQ3<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ3<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
                                       vector<Point<1> >  &) const {
@@ -197,7 +195,6 @@ void FEQ3<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FEQ3<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
                                     FullMatrix<double> &local_mass_matrix) const {
@@ -236,8 +233,6 @@ void FEQ3<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 #endif
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -264,7 +259,6 @@ FEQ3<2>::FEQ3 () :
 };
 
 
-
 template <>
 FEQ3<2>::FEQ3 (const int) :
                FEQ1Mapping<2> (0, 0, 16, 0, 1,
@@ -274,7 +268,6 @@ FEQ3<2>::FEQ3 (const int) :
 };
 
 
-
 template <>
 void FEQ3<2>::initialize_matrices () {
   prolongation[0](0,0) = 1.0;
@@ -697,7 +690,6 @@ void FEQ3<2>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ3<2>::shape_value (const unsigned int i,
@@ -763,7 +755,6 @@ xi*xi)*eta*eta*eta;
 };
 
 
-
 template <>
 Tensor<1,2>
 FEQ3<2>::shape_grad (const unsigned int i,
@@ -817,7 +808,6 @@ FEQ3<2>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,2>
 FEQ3<2>::shape_grad_grad (const unsigned int i,
@@ -920,7 +910,6 @@ FEQ3<2>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ3<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
                                           FullMatrix<double> &local_mass_matrix) const {
@@ -1482,7 +1471,6 @@ void FEQ3<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ3<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -1507,7 +1495,6 @@ void FEQ3<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
 };
 
 
-
 template <>
 void FEQ3<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
                                  vector<Point<2> >  &support_points) const {
@@ -1581,7 +1568,6 @@ void FEQ3<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ3<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
                                       vector<Point<2> >  &support_points) const {
@@ -1595,12 +1581,9 @@ void FEQ3<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
 };
 
 
-
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 // ignore the following, since it doesn't compile properly. it simply
@@ -1871,7 +1854,6 @@ FEQ3<3>::FEQ3 () :
 };
 
 
-
 template <>
 FEQ3<3>::FEQ3 (const int) :
                FEQ1Mapping<3> (0, 0, 0, 64, 1,
@@ -1881,7 +1863,6 @@ FEQ3<3>::FEQ3 (const int) :
 };
 
 
-
 template <>
 void FEQ3<3>::initialize_matrices ()
 {
@@ -9887,7 +9868,7 @@ void FEQ3<3>::initialize_matrices ()
       prolongation[7](63,62) = 225.0/256.0;
 
 
-      restriction[0](0,0) = 1.0;
+restriction[0](0,0) = 1.0;
       restriction[0](8,9) = 1.0;
       restriction[0](14,15) = 1.0;
       restriction[0](24,25) = 1.0;
@@ -9954,7 +9935,6 @@ void FEQ3<3>::initialize_matrices ()
 };
 
 
-
 template <>
 double
 FEQ3<3>::shape_value (const unsigned int i,
@@ -10567,7 +10547,6 @@ xi*xi+6561.0/2.0*xi*xi*xi)*eta*eta+(-6561.0/8.0*xi+6561.0/2.0*xi*xi-19683.0/8.0
 };
 
 
-
 template <>
 Tensor<1,3>
 FEQ3<3>::shape_grad (const unsigned int i,
@@ -10782,7 +10761,6 @@ FEQ3<3>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,3>
 FEQ3<3>::shape_grad_grad (const unsigned int i,
@@ -11398,7 +11376,6 @@ return_value[2][2] = 2.0*(729.0/2.0*xi-1458.0*xi*xi+2187.0/2.0*xi*xi*xi)*eta+2.0
 };
 
 
-
 template <>
 void
 FEQ3<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
@@ -11413,7 +11390,6 @@ FEQ3<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ3<3>::get_unit_support_points (vector<Point<3> > &unit_points) const
 {
@@ -11486,7 +11462,6 @@ void FEQ3<3>::get_unit_support_points (vector<Point<3> > &unit_points) const
 };
 
 
-
 template <>
 void FEQ3<3>::get_support_points (const typename DoFHandler<3>::cell_iterator &cell,
                                  vector<Point<3> >  &support_points) const
@@ -11865,7 +11840,6 @@ void FEQ3<3>::get_support_points (const typename DoFHandler<3>::cell_iterator &c
 };
 
 
-
 template <>
 void FEQ3<3>::get_face_support_points (const typename DoFHandler<3>::face_iterator &face,
                                       vector<Point<3> >  &support_points) const
@@ -11904,7 +11878,6 @@ void FEQ3<3>::get_face_support_points (const typename DoFHandler<3>::face_iterat
 };
 
 
-
 #else  // 0
 
 // provide dummy implementations of the functions above. for the
@@ -11919,7 +11892,6 @@ FEQ3<3>::FEQ3 () :
 };
 
 
-
 template <>
 FEQ3<3>::FEQ3 (const int) :
                FEQ1Mapping<3> (0, 0, 0, 64, 1,
@@ -11929,7 +11901,6 @@ FEQ3<3>::FEQ3 (const int) :
 };
 
 
-
 template <>
 void FEQ3<3>::initialize_matrices ()
 {
@@ -11937,7 +11908,6 @@ void FEQ3<3>::initialize_matrices ()
 };
 
 
-
 template <>
 double
 FEQ3<3>::shape_value (const unsigned int,
@@ -11948,7 +11918,6 @@ FEQ3<3>::shape_value (const unsigned int,
 };
 
 
-
 template <>
 Tensor<1,3>
 FEQ3<3>::shape_grad (const unsigned int,
@@ -11959,7 +11928,6 @@ FEQ3<3>::shape_grad (const unsigned int,
 };
 
 
-
 template <>
 Tensor<2,3>
 FEQ3<3>::shape_grad_grad (const unsigned int,
@@ -11970,7 +11938,6 @@ FEQ3<3>::shape_grad_grad (const unsigned int,
 };
 
 
-
 template <>
 void
 FEQ3<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
@@ -11980,7 +11947,6 @@ FEQ3<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ3<3>::get_unit_support_points (vector<Point<3> > &) const
 {
@@ -11988,7 +11954,6 @@ void FEQ3<3>::get_unit_support_points (vector<Point<3> > &) const
 };
 
 
-
 template <>
 void FEQ3<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
                                  vector<Point<3> >  &) const
@@ -11997,7 +11962,6 @@ void FEQ3<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ3<3>::get_face_support_points (const DoFHandler<3>::face_iterator &,
                                       vector<Point<3> >  &) const
@@ -12006,7 +11970,6 @@ void FEQ3<3>::get_face_support_points (const DoFHandler<3>::face_iterator &,
 };
 
 
-
 #endif // 0
 #endif // deal_II_dimension == 3
 
index c923a84ffe2cd277bccf6cad48b5c396d65325d6..2666c8cf2412342e509664c5989476326089eb62 100644 (file)
@@ -1,8 +1,18 @@
-/* $Id$ */
-/*            Ralf Hartmann, University of Heidelberg, Dez 98               */
+//----------------------------  fe_lib.dg.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.dg.cc  ---------------------------
 
-#include<fe/fe_lib.dg.h>
 
+#include<fe/fe_lib.dg.h>
 
 
 template<int dim>
@@ -25,7 +35,6 @@ FEDG_Q4<dim>::FEDG_Q4():
                FEQ4<dim>(1) {};
 
 
-
 template <int dim>
 void
 FEDG_Q1<dim>::get_face_support_points (const typename DoFHandler<dim>::face_iterator &,
@@ -62,8 +71,6 @@ FEDG_Q4<dim>::get_face_support_points (const typename DoFHandler<dim>::face_iter
 };
 
 
-
-
 // explicit instantiations
 template class FEDG_Q1<deal_II_dimension>;
 template class FEDG_Q2<deal_II_dimension>;
index 60292f722e621f76e5c67fe5c1b9c4037a2fef85..75ae78833625b8ad989be47901da1caf22c878d1 100644 (file)
@@ -1,4 +1,15 @@
-/*            Ralf Hartmann, University of Heidelberg, Dez 98               */
+//----------------------------  fe_lib.dg.constant.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.dg.constant.cc  ---------------------------
 
 
 #include <fe/fe_lib.dg.h>
@@ -8,9 +19,6 @@
 #include <algorithm>
 
 
-
-
-
 template <int dim>
 FEDG_Q0<dim>::FEDG_Q0 () :
                FEQ1Mapping<dim> (0, 
@@ -28,7 +36,6 @@ FEDG_Q0<dim>::FEDG_Q0 () :
 };
 
 
-
 #if deal_II_dimension == 1
 
 
@@ -53,7 +60,6 @@ FEDG_Q0<dim>::shape_value (const unsigned int i,
 };
 
 
-
 template <int dim>
 inline
 Tensor<1,dim>
@@ -65,7 +71,6 @@ FEDG_Q0<dim>::shape_grad (const unsigned int i,
 };
 
 
-
 template <int dim>
 inline
 Tensor<2,dim>
@@ -78,7 +83,6 @@ FEDG_Q0<dim>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <int dim>
 void FEDG_Q0<dim>::get_local_mass_matrix (const DoFHandler<dim>::cell_iterator &cell,
                                               FullMatrix<double> &local_mass_matrix) const {
@@ -91,7 +95,6 @@ void FEDG_Q0<dim>::get_local_mass_matrix (const DoFHandler<dim>::cell_iterator &
 };
 
 
-
 template <int dim>
 void
 FEDG_Q0<dim>::get_unit_support_points (vector<Point<dim> > &unit_points) const {
@@ -100,7 +103,7 @@ FEDG_Q0<dim>::get_unit_support_points (vector<Point<dim> > &unit_points) const {
   for (unsigned int d=0; d<dim; ++d)
     unit_points[0](d) = 0.5;
 };
-  
+
 
 template <int dim>
 void
@@ -122,7 +125,6 @@ FEDG_Q0<dim>::get_face_support_points (const typename DoFHandler<dim>::face_iter
 };
 
 
-
 // explicit instantiations
 
 template class FEDG_Q0<deal_II_dimension>;
index ff6751470d439a7940459b7cbef607826f3535dc..09b93bd42c30ec475c6d052fab924627a3ff70b1 100644 (file)
@@ -1,6 +1,15 @@
-
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_lib.linear.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.linear.cc  ---------------------------
 
 
 #include <fe/fe_lib.lagrange.h>
 #include <algorithm>
 
 
-
-
 // declare explicit specializations before use:
 template <> void FEQ1<deal_II_dimension>::initialize_matrices ();
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -38,8 +43,6 @@ FEQ1<1>::FEQ1 (const int) :
 };
 
 
-
-
 template <>
 void FEQ1<1>::initialize_matrices () {
                                   // for restriction and prolongation matrices:
@@ -67,7 +70,6 @@ void FEQ1<1>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ1<1>::shape_value(const unsigned int i,
@@ -83,7 +85,6 @@ FEQ1<1>::shape_value(const unsigned int i,
 }
 
 
-
 template <>
 inline
 Tensor<1,1>
@@ -105,7 +106,6 @@ FEQ1<1>::shape_grad(const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<2,1>
@@ -119,14 +119,12 @@ FEQ1<1>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1<1>::get_unit_support_points (vector<Point<1> >  &support_points) const {
   FiniteElement<1>::get_unit_support_points (support_points);
 };
 
 
-
 template <>
 void FEQ1<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
                                  vector<Point<1> >  &support_points) const {
@@ -134,7 +132,6 @@ void FEQ1<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ1<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
                                       vector<Point<1> >  &) const {
@@ -142,7 +139,6 @@ void FEQ1<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FEQ1<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
                                         FullMatrix<double> &local_mass_matrix) const {
@@ -161,8 +157,6 @@ void FEQ1<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 #endif
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -177,7 +171,6 @@ FEQ1<2>::FEQ1 () :
 };
 
 
-
 template <>
 FEQ1<2>::FEQ1 (const int) :
                FEQ1Mapping<2> (0, 0, 4, 0, 1,
@@ -187,7 +180,6 @@ FEQ1<2>::FEQ1 (const int) :
 };
 
 
-
 template <>
 void FEQ1<2>::initialize_matrices () {
   restriction[0](0,0) = 1.0;
@@ -237,8 +229,6 @@ void FEQ1<2>::initialize_matrices () {
 };
 
 
-
-
 template <>
 inline
 double
@@ -257,7 +247,6 @@ FEQ1<2>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,2>
@@ -281,7 +270,6 @@ FEQ1<2>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<2,2>
@@ -311,7 +299,6 @@ FEQ1<2>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
                                         FullMatrix<double> &local_mass_matrix) const {
@@ -417,7 +404,6 @@ void FEQ1<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ1<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -428,7 +414,7 @@ void FEQ1<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   unit_points[2] = Point<2> (1,1);
   unit_points[3] = Point<2> (0,1);
 };
-  
+
 
 #endif
 
@@ -457,7 +443,6 @@ FEQ1<3>::FEQ1 () :
 };
 
 
-
 template <>
 FEQ1<3>::FEQ1 (const int) :
                FEQ1Mapping<3> (0, 0, 0, 8, 1,
@@ -467,7 +452,6 @@ FEQ1<3>::FEQ1 (const int) :
 };
 
 
-
 template <>
 void FEQ1<3>::initialize_matrices () {
   restriction[0](0,0) = 1.0;
@@ -698,8 +682,6 @@ void FEQ1<3>::initialize_matrices () {
 };
 
 
-
-
 template <>
 inline
 double
@@ -722,7 +704,6 @@ FEQ1<3>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,3>
@@ -766,7 +747,6 @@ FEQ1<3>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<2,3>
@@ -848,7 +828,6 @@ FEQ1<3>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
                                         FullMatrix<double> &local_mass_matrix) const {
@@ -861,7 +840,6 @@ void FEQ1<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ1<3>::get_unit_support_points (vector<Point<3> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -876,10 +854,9 @@ void FEQ1<3>::get_unit_support_points (vector<Point<3> > &unit_points) const {
   unit_points[6] = Point<3> (1,1,1);
   unit_points[7] = Point<3> (0,1,1);
 };
-  
 
-#endif
 
+#endif
 
 
 template <int dim>
@@ -894,7 +871,6 @@ FEQ1<dim>::get_support_points (const typename DoFHandler<dim>::cell_iterator &ce
 };
 
 
-
 template <int dim>
 void
 FEQ1<dim>::get_face_support_points (const typename DoFHandler<dim>::face_iterator &face,
@@ -909,8 +885,6 @@ FEQ1<dim>::get_face_support_points (const typename DoFHandler<dim>::face_iterato
 };
 
 
-
-
 // explicit instantiations
 
 template class FEQ1<deal_II_dimension>;
index 5a44fa9e7af0e6e5f9565006bf1b34f7c7de91f3..7d97394c37c368676b23300829107c293085674e 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_lib.quadratic.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.quadratic.cc  ---------------------------
 
 
 #include <fe/fe_lib.lagrange.h>
 #include <algorithm>
 
 
-
 // declare explicit specializations before use:
 template <> void FEQ2<deal_II_dimension>::initialize_matrices ();
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -25,7 +33,6 @@ FEQ2<1>::FEQ2 () :
 };
 
 
-
 template <>
 FEQ2<1>::FEQ2 (const int) :
                FEQ1Mapping<1> (0, 3, 0, 0, 1,
@@ -34,7 +41,6 @@ FEQ2<1>::FEQ2 (const int) :
 };
 
 
-
 template <>
 void FEQ2<1>::initialize_matrices () {
 /*
@@ -59,8 +65,7 @@ void FEQ2<1>::initialize_matrices () {
   od;
 
 
-  
-  # to get the restriction (interpolation) matrices, evaluate
+# to get the restriction (interpolation) matrices, evaluate
   # the basis functions on the child cells at the global
   # interpolation points
 
@@ -119,7 +124,6 @@ void FEQ2<1>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ2<1>::shape_value(const unsigned int i,
@@ -137,7 +141,6 @@ FEQ2<1>::shape_value(const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,1>
 FEQ2<1>::shape_grad(const unsigned int i,
@@ -160,7 +163,6 @@ FEQ2<1>::shape_grad(const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,1>
 FEQ2<1>::shape_grad_grad (const unsigned int i,
@@ -185,14 +187,12 @@ FEQ2<1>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ2<1>::get_unit_support_points (vector<Point<1> > &unit_points) const {
   FiniteElement<1>::get_unit_support_points (unit_points);
 };
 
 
-
 template <>
 void FEQ2<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
                                  vector<Point<1> >  &support_points) const {
@@ -200,7 +200,6 @@ void FEQ2<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ2<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
                                       vector<Point<1> >  &) const {
@@ -208,7 +207,6 @@ void FEQ2<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FEQ2<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
                                     FullMatrix<double> &local_mass_matrix) const {
@@ -249,7 +247,6 @@ FEQ2<2>::FEQ2 () :
 };
 
 
-
 template <>
 FEQ2<2>::FEQ2 (const int) :
                FEQ1Mapping<2> (0, 0, 9, 0, 1,
@@ -259,7 +256,6 @@ FEQ2<2>::FEQ2 (const int) :
 };
 
 
-
 template <>
 void FEQ2<2>::initialize_matrices () {
 /*
@@ -645,7 +641,6 @@ void FEQ2<2>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ2<2>::shape_value (const unsigned int i,
@@ -671,7 +666,6 @@ FEQ2<2>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,2>
 FEQ2<2>::shape_grad (const unsigned int i,
@@ -711,7 +705,6 @@ FEQ2<2>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,2>
 FEQ2<2>::shape_grad_grad (const unsigned int i,
@@ -784,7 +777,6 @@ FEQ2<2>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ2<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
                                               FullMatrix<double> &local_mass_matrix) const {
@@ -1059,7 +1051,6 @@ void FEQ2<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ2<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -1076,7 +1067,6 @@ void FEQ2<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   unit_points[8] = Point<2> (0.5,0.5);
 };
 
-  
 
 template <>
 void FEQ2<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
@@ -1105,7 +1095,6 @@ void FEQ2<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ2<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
                                       vector<Point<2> >  &support_points) const {
@@ -1120,7 +1109,6 @@ void FEQ2<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1210,7 +1198,6 @@ FEQ2<3>::FEQ2 () :
 };
 
 
-
 template <>
 FEQ2<3>::FEQ2 (const int) :
                FEQ1Mapping<3> (0, 0, 0, 27, 1,
@@ -1220,7 +1207,6 @@ FEQ2<3>::FEQ2 (const int) :
 };
 
 
-
 template <>
 void FEQ2<3>::initialize_matrices () {
   prolongation[0](0,0) = 1.0;
@@ -2291,7 +2277,6 @@ void FEQ2<3>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ2<3>::shape_value (const unsigned int i,
@@ -2385,7 +2370,6 @@ xi)*eta*eta)*zeta+((-16.0+48.0*xi-32.0*xi*xi)*eta+(16.0-48.0*xi+32.0*xi*xi)*eta
 };
 
 
-
 template <>
 Tensor<1,3>
 FEQ2<3>::shape_grad (const unsigned int i,
@@ -2489,7 +2473,6 @@ FEQ2<3>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,3>
 FEQ2<3>::shape_grad_grad (const unsigned int i,
@@ -2773,7 +2756,6 @@ return_value[2][2] = 2.0*(-64.0*xi+64.0*xi*xi)*eta+2.0*(64.0*xi-64.0*xi*xi)*eta*
 };
 
 
-
 template <>
 void FEQ2<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
                                               FullMatrix<double> &local_mass_matrix) const {
@@ -2786,7 +2768,6 @@ void FEQ2<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ2<3>::get_unit_support_points (vector<Point<3> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -2821,7 +2802,6 @@ void FEQ2<3>::get_unit_support_points (vector<Point<3> > &unit_points) const {
   unit_points[26] = Point<3>(1/2, 1/2, 1/2);
 };
 
-  
 
 template <>
 void FEQ2<3>::get_support_points (const DoFHandler<3>::cell_iterator &cell,
@@ -2922,7 +2902,6 @@ void FEQ2<3>::get_support_points (const DoFHandler<3>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ2<3>::get_face_support_points (const DoFHandler<3>::face_iterator &face,
                                       vector<Point<3> >  &support_points) const {
@@ -2942,9 +2921,6 @@ void FEQ2<3>::get_face_support_points (const DoFHandler<3>::face_iterator &face,
 #endif
 
 
-
-
-
 // explicit instantiations
 
 template class FEQ2<deal_II_dimension>;
index 5f704d46c2cff6d8689685a8c046d1e37fbb6061..711be07606cf97c3db69746143a4c2410e314d3f 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_lib.quartic.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_lib.quartic.cc  ---------------------------
 
 
 #include <fe/fe_lib.lagrange.h>
 #include <algorithm>
 
 
-
 // declare explicit specializations before use:
 template <> void FEQ4<deal_II_dimension>::initialize_matrices ();
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -33,8 +41,6 @@ FEQ4<1>::FEQ4 (const int) :
 };
 
 
-
-
 template <>
 void FEQ4<1>::initialize_matrices () {
   prolongation[0](0,0) = 1.0;
@@ -73,7 +79,6 @@ void FEQ4<1>::initialize_matrices () {
 };
 
 
-
 template <>
 double
 FEQ4<1>::shape_value(const unsigned int i,
@@ -93,7 +98,6 @@ FEQ4<1>::shape_value(const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,1>
 FEQ4<1>::shape_grad(const unsigned int i,
@@ -118,7 +122,6 @@ FEQ4<1>::shape_grad(const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,1>
 FEQ4<1>::shape_grad_grad (const unsigned int i,
@@ -141,14 +144,12 @@ FEQ4<1>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ4<1>::get_unit_support_points (vector<Point<1> > &unit_points) const {
   FiniteElement<1>::get_unit_support_points (unit_points);
 };
 
 
-
 template <>
 void FEQ4<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
                                  vector<Point<1> >  &support_points) const {
@@ -156,7 +157,6 @@ void FEQ4<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ4<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
                                       vector<Point<1> >  &) const {
@@ -164,7 +164,6 @@ void FEQ4<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FEQ4<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
                                             FullMatrix<double> &local_mass_matrix) const {
@@ -214,8 +213,6 @@ void FEQ4<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 #endif
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -251,7 +248,6 @@ FEQ4<2>::FEQ4 () :
 };
 
 
-
 template <>
 FEQ4<2>::FEQ4 (const int) :
                FEQ1Mapping<2> (0, 0, 25, 0, 1,
@@ -261,7 +257,6 @@ FEQ4<2>::FEQ4 (const int) :
 };
 
 
-
 template <>
 void FEQ4<2>::initialize_matrices () {
   prolongation[0](0,0) = 1.0;
@@ -1127,7 +1122,6 @@ FEQ4<2>::shape_value (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<1,2>
 FEQ4<2>::shape_grad (const unsigned int i,
@@ -1199,7 +1193,6 @@ FEQ4<2>::shape_grad (const unsigned int i,
 };
 
 
-
 template <>
 Tensor<2,2>
 FEQ4<2>::shape_grad_grad (const unsigned int i,
@@ -1338,7 +1331,6 @@ FEQ4<2>::shape_grad_grad (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ4<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
                                             FullMatrix<double> &local_mass_matrix) const {
@@ -2604,7 +2596,6 @@ void FEQ4<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ4<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
   Assert (unit_points.size() == dofs_per_cell,
@@ -2638,7 +2629,6 @@ void FEQ4<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
 };
 
 
-
 template <>
 void FEQ4<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
                                  vector<Point<2> >  &support_points) const {
@@ -2747,7 +2737,6 @@ void FEQ4<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
 };
 
 
-
 template <>
 void FEQ4<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
                                       vector<Point<2> >  &support_points) const {
@@ -2762,12 +2751,9 @@ void FEQ4<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
 };
 
 
-
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 // provide dummy implementations of the functions above. the reason is
@@ -2783,7 +2769,6 @@ FEQ4<3>::FEQ4 () :
 };
 
 
-
 template <>
 FEQ4<3>::FEQ4 (const int) :
                FEQ1Mapping<3> (0, 0, 0, 64, 1,
@@ -2793,7 +2778,6 @@ FEQ4<3>::FEQ4 (const int) :
 };
 
 
-
 template <>
 void FEQ4<3>::initialize_matrices ()
 {
@@ -2801,7 +2785,6 @@ void FEQ4<3>::initialize_matrices ()
 };
 
 
-
 template <>
 double
 FEQ4<3>::shape_value (const unsigned int,
@@ -2812,7 +2795,6 @@ FEQ4<3>::shape_value (const unsigned int,
 };
 
 
-
 template <>
 Tensor<1,3>
 FEQ4<3>::shape_grad (const unsigned int,
@@ -2823,7 +2805,6 @@ FEQ4<3>::shape_grad (const unsigned int,
 };
 
 
-
 template <>
 Tensor<2,3>
 FEQ4<3>::shape_grad_grad (const unsigned int,
@@ -2834,7 +2815,6 @@ FEQ4<3>::shape_grad_grad (const unsigned int,
 };
 
 
-
 template <>
 void
 FEQ4<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
@@ -2844,7 +2824,6 @@ FEQ4<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ4<3>::get_unit_support_points (vector<Point<3> > &) const
 {
@@ -2852,7 +2831,6 @@ void FEQ4<3>::get_unit_support_points (vector<Point<3> > &) const
 };
 
 
-
 template <>
 void FEQ4<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
                                  vector<Point<3> >  &) const
@@ -2861,7 +2839,6 @@ void FEQ4<3>::get_support_points (const DoFHandler<3>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ4<3>::get_face_support_points (const DoFHandler<3>::face_iterator &,
                                       vector<Point<3> >  &) const
@@ -2870,15 +2847,9 @@ void FEQ4<3>::get_face_support_points (const DoFHandler<3>::face_iterator &,
 };
 
 
-
 #endif // deal_II_dimension == 3
 
 
-
-
-
-
-
 // explicit instantiations
 
 template class FEQ4<deal_II_dimension>;
index eb1f27b455830ecec238c917aeb572a8fe6aba8d..2bac4eaa732f151faa58bd883c0f76960fa014c1 100644 (file)
@@ -1,13 +1,20 @@
-/* $Id$ */
-/* Copyright W. Bangerth, G. Kanschat University of Heidelberg, 1999 */
+//----------------------------  fe_system.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_system.cc  ---------------------------
 
 
 #include <fe/fe_system.h>
 
 
-
-
-
 template <int dim>
 FESystem<dim>::~FESystem ()
 {
@@ -262,7 +269,6 @@ FESystem<dim>::build_face_table()
 }
 
 
-
 template <int dim>
 void FESystem<dim>::build_interface_constraints () 
 {
@@ -457,9 +463,6 @@ void FESystem<dim>::build_interface_constraints ()
 };
 
 
-
-
-
 template <int dim>
 void FESystem<dim>::initialize ()
 {
@@ -486,15 +489,13 @@ void FESystem<dim>::initialize ()
          };
 
 
-                                  // now set up the interface constraints.
+// now set up the interface constraints.
                                   // this is kind'o hairy, so don't try
                                   // to do it dimension independent
   build_interface_constraints ();
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -717,8 +718,6 @@ FESystem<dim>::compute_restriction_is_additive_flags (const FiniteElement<dim> &
   return tmp;
 };
 
-               
-
 
 template <int dim>
 double
@@ -734,7 +733,6 @@ FESystem<dim>::shape_value (const unsigned int i,
 };
 
 
-
 template <int dim>
 Tensor<1,dim>
 FESystem<dim>::shape_grad (const unsigned int  i,
@@ -749,7 +747,6 @@ FESystem<dim>::shape_grad (const unsigned int  i,
 };
 
 
-
 template <int dim>
 Tensor<2,dim>
 FESystem<dim>::shape_grad_grad (const unsigned int  i,
@@ -758,14 +755,13 @@ FESystem<dim>::shape_grad_grad (const unsigned int  i,
   Assert((i<dofs_per_cell), ExcIndexRange(i, 0, dofs_per_cell));
 
 
-  pair<unsigned,unsigned> comp = system_to_component_index(i);
+pair<unsigned,unsigned> comp = system_to_component_index(i);
   
   return base_element(component_to_base_table[comp.first])
     .shape_grad_grad(comp.second, p);
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_unit_support_points (
   vector<Point<dim> > &unit_support_points) const
@@ -817,7 +813,6 @@ void FESystem<dim>::get_unit_support_points (
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_support_points (const DoFHandler<dim>::cell_iterator &cell,
                                        vector<Point<dim> > &support_points) const
@@ -847,7 +842,6 @@ void FESystem<dim>::get_support_points (const DoFHandler<dim>::cell_iterator &ce
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_face_support_points (const DoFHandler<dim>::face_iterator & face,
                                             vector<Point<dim> > & support_points) const
@@ -875,7 +869,6 @@ void FESystem<dim>::get_face_support_points (const DoFHandler<dim>::face_iterato
 }
 
 
-
 template <int dim>
 void FESystem<dim>::get_local_mass_matrix (const DoFHandler<dim>::cell_iterator &cell,
                                           FullMatrix<double>  &local_mass_matrix) const
@@ -918,7 +911,6 @@ void FESystem<dim>::get_local_mass_matrix (const DoFHandler<dim>::cell_iterator
 };
 
 
-
 template <int dim>
 double FESystem<dim>::shape_value_transform (const unsigned int i,
                                             const Point<dim>  &p) const
@@ -935,7 +927,6 @@ Tensor<1,dim> FESystem<dim>::shape_grad_transform (const unsigned int i,
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_face_jacobians (const DoFHandler<dim>::face_iterator &face,
                                        const vector<Point<dim-1> > &unit_points,
@@ -946,7 +937,6 @@ void FESystem<dim>::get_face_jacobians (const DoFHandler<dim>::face_iterator &fa
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_subface_jacobians (const DoFHandler<dim>::face_iterator &face,
                                           const unsigned int           subface_no,
@@ -958,8 +948,6 @@ void FESystem<dim>::get_subface_jacobians (const DoFHandler<dim>::face_iterator
 };
 
 
-
-
 template <int dim>
 void FESystem<dim>::get_normal_vectors (const DoFHandler<dim>::cell_iterator &cell,
                                        const unsigned int          face_no,
@@ -971,7 +959,6 @@ void FESystem<dim>::get_normal_vectors (const DoFHandler<dim>::cell_iterator &ce
 };
 
 
-
 template <int dim>
 void FESystem<dim>::get_normal_vectors (const DoFHandler<dim>::cell_iterator &cell,
                                        const unsigned int          face_no,
@@ -1036,10 +1023,8 @@ FESystem<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
     }
 }
 
-    
 
 // explicit instantiations
 template class FESystem<deal_II_dimension>;
 
 
-
index 7bd312b2e598654e517952cb7095096381c621b1..8bd23bd5fb405fa984a57c92641bc84814f01e9e 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  fe_values.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_values.cc  ---------------------------
 
 
 #include <fe/fe.h>
@@ -45,8 +55,6 @@ FEValuesBase<dim>::FEValuesBase (const unsigned int n_q_points,
 {};
 
 
-
-
 template <int dim>
 double FEValuesBase<dim>::shape_value (const unsigned int i,
                                       const unsigned int j) const {
@@ -62,7 +70,6 @@ double FEValuesBase<dim>::shape_value (const unsigned int i,
 };
 
 
-
 template <int dim>
 void FEValuesBase<dim>::get_function_values (const Vector<double> &fe_function,
                                             vector<double>       &values) const
@@ -127,7 +134,6 @@ void FEValuesBase<dim>::get_function_values (const Vector<double>     &fe_functi
 };
 
 
-
 template <int dim>
 const Tensor<1,dim> &
 FEValuesBase<dim>::shape_grad (const unsigned int i,
@@ -143,7 +149,6 @@ FEValuesBase<dim>::shape_grad (const unsigned int i,
 };
 
 
-
 template <int dim>
 void FEValuesBase<dim>::get_function_grads (const Vector<double>   &fe_function,
                                            vector<Tensor<1,dim> > &gradients) const
@@ -226,7 +231,6 @@ FEValuesBase<dim>::shape_2nd_derivative (const unsigned int i,
 };
 
 
-
 template <int dim>
 void FEValuesBase<dim>::get_function_2nd_derivatives (const Vector<double>   &fe_function,
                                                      vector<Tensor<2,dim> > &second_derivatives) const
@@ -259,7 +263,6 @@ void FEValuesBase<dim>::get_function_2nd_derivatives (const Vector<double>   &fe
 };
 
 
-
 template <int dim>
 const Point<dim> &
 FEValuesBase<dim>::quadrature_point (const unsigned int i) const
@@ -271,7 +274,6 @@ FEValuesBase<dim>::quadrature_point (const unsigned int i) const
 };
 
 
-
 template <int dim>
 const Point<dim> &
 FEValuesBase<dim>::support_point (const unsigned int i) const
@@ -283,7 +285,6 @@ FEValuesBase<dim>::support_point (const unsigned int i) const
 };
 
 
-
 template <int dim>
 double FEValuesBase<dim>::JxW (const unsigned int i) const
 {
@@ -294,8 +295,6 @@ double FEValuesBase<dim>::JxW (const unsigned int i) const
 };
 
 
-
-
 /*------------------------------- FEValues -------------------------------*/
 
 template <int dim>
@@ -344,11 +343,6 @@ FEValues<dim>::FEValues (const FiniteElement<dim> &fe,
 };
 
 
-
-
-
-
-
 template <int dim>
 void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell) {
   present_cell = cell;
@@ -404,7 +398,7 @@ void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell)
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-                                          // second part:
+// second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1, jacobi_matrices_grad[j], 2, unit_shape_gradients[i][j]);
                                           // tmp1_kj J_ki
@@ -415,9 +409,9 @@ void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell)
                                           // add up first contribution
          shape_2nd_derivatives[i][j] += tmp2;
        };
-  
-  
-                                  // compute Jacobi determinants in
+
+
+// compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
@@ -428,9 +422,6 @@ void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell)
 };
 
 
-
-
-
 /*------------------------------- FEFaceValuesBase --------------------------*/
 
 
@@ -467,7 +458,6 @@ FEFaceValuesBase<dim>::FEFaceValuesBase (const unsigned int n_q_points,
 {};
 
 
-
 template <int dim>
 const Point<dim> &
 FEFaceValuesBase<dim>::normal_vector (const unsigned int i) const {
@@ -479,10 +469,6 @@ FEFaceValuesBase<dim>::normal_vector (const unsigned int i) const {
 };
 
 
-
-
-
-
 /*------------------------------- FEFaceValues -------------------------------*/
 
 
@@ -534,7 +520,6 @@ FEFaceValues<dim>::FEFaceValues (const FiniteElement<dim> &fe,
 };
 
 
-
 template <int dim>
 void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell,
                                const unsigned int                             face_no) {
@@ -592,7 +577,7 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
       };
 
 
-  Tensor<2,dim> tmp1, tmp2;
+Tensor<2,dim> tmp1, tmp2;
   if (update_flags & update_second_derivatives)
     for (unsigned int i=0; i<fe->dofs_per_cell; ++i)
       for (unsigned int j=0; j<n_quadrature_points; ++j)
@@ -603,7 +588,7 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-                                          // second part:
+// second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1,
                    jacobi_matrices_grad[j], 2,
@@ -616,9 +601,9 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
                                           // add up first contribution
          shape_2nd_derivatives[i][j] += tmp2;
        };
-  
-  
-                                  // compute Jacobi determinants in
+
+
+// compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
@@ -629,10 +614,6 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
 };
 
 
-
-
-
-
 /*------------------------------- FESubFaceValues -------------------------------*/
 
 
@@ -705,7 +686,6 @@ FESubfaceValues<dim>::FESubfaceValues (const FiniteElement<dim> &fe,
 };
 
 
-
 template <int dim>
 void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell,
                                   const unsigned int         face_no,
@@ -778,7 +758,7 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-                                          // second part:
+// second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1,
                    jacobi_matrices_grad[j], 2,
@@ -791,9 +771,9 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
                                           // add up first contribution
          shape_2nd_derivatives[i][j] += tmp2;
        };
-  
-  
-                                  // compute Jacobi determinants in
+
+
+// compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
@@ -804,9 +784,6 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
 };
 
 
-
-
-
 /*------------------------------- Explicit Instantiations -------------*/
 
 template class FEValuesBase<deal_II_dimension>;
index 06acd7e7dc09a8e623eb71852e614b9e60e9b2c0..0218d03fe1653aa4f35214c53d683f5ed6c532f3 100644 (file)
@@ -1,7 +1,16 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  q1_mapping.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  q1_mapping.cc  ---------------------------
 
-// moved from file fe_linear_mapping.cc
 
 #include <fe/q1_mapping.h>
 #include <base/quadrature.h>
 #include <cmath>
 
 
-
 /*---------------------------- FEQ1Mapping ----------------------------------*/
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -36,7 +43,6 @@ FEQ1Mapping<1>::FEQ1Mapping (const unsigned int dofs_per_vertex,
 };
 
 
-
 template <>
 inline
 double
@@ -54,7 +60,6 @@ FEQ1Mapping<1>::shape_value_transform (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,1>
@@ -71,7 +76,6 @@ FEQ1Mapping<1>::shape_grad_transform(const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
                                             const vector<Point<0> > &,
@@ -80,7 +84,6 @@ void FEQ1Mapping<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator &,
                                                const unsigned int           ,
@@ -90,7 +93,6 @@ void FEQ1Mapping<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator &
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                             const unsigned int,
@@ -100,7 +102,6 @@ void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                         const unsigned int,
@@ -111,7 +112,6 @@ void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
                                     const vector<Point<1> > &unit_points,
@@ -135,11 +135,9 @@ void FEQ1Mapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
-
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -160,7 +158,6 @@ FEQ1Mapping<2>::FEQ1Mapping (const unsigned int dofs_per_vertex,
 };
 
 
-
 template <>
 inline
 double
@@ -179,7 +176,6 @@ FEQ1Mapping<2>::shape_value_transform (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,2>
@@ -198,7 +194,6 @@ FEQ1Mapping<2>::shape_grad_transform (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1Mapping<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &face,
                                             const vector<Point<1> > &unit_points,
@@ -219,7 +214,6 @@ void FEQ1Mapping<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &fac
 };
 
 
-
 template <>
 void FEQ1Mapping<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator &face,
                                                const unsigned int           ,
@@ -243,7 +237,6 @@ void FEQ1Mapping<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator &
 };
 
 
-
 template <>
 void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                             const unsigned int       face_no,
@@ -274,7 +267,6 @@ void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cel
 };
 
 
-
 template <>
 void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                             const unsigned int       face_no,
@@ -313,7 +305,6 @@ void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cel
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -333,7 +324,6 @@ FEQ1Mapping<3>::FEQ1Mapping (const unsigned int dofs_per_vertex,
 {};
 
 
-
 template <>
 inline
 double
@@ -356,7 +346,6 @@ FEQ1Mapping<3>::shape_value_transform (const unsigned int i,
 };
 
 
-
 template <>
 inline
 Tensor<1,3>
@@ -395,7 +384,6 @@ FEQ1Mapping<3>::shape_grad_transform (const unsigned int i,
 };
 
 
-
 template <>
 void FEQ1Mapping<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &face,
                                             const vector<Point<2> > &unit_points,
@@ -467,7 +455,6 @@ void FEQ1Mapping<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &fac
 };
 
 
-
 template <>
 void FEQ1Mapping<3>::get_subface_jacobians (const DoFHandler<3>::face_iterator &/*face*/,
                                                const unsigned int           ,
@@ -478,7 +465,6 @@ void FEQ1Mapping<3>::get_subface_jacobians (const DoFHandler<3>::face_iterator &
 };
 
 
-
 template <>
 void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &cell,
                                             const unsigned int       face_no,
@@ -533,7 +519,6 @@ void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &cel
 };
 
 
-
 template <>
 void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &/*cell*/,
                                             const unsigned int       /*face_no*/,
@@ -552,7 +537,6 @@ void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &/*c
 #endif
 
 
-
 template <int dim>
 void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
                                       const vector<Point<dim> >            &unit_points,
@@ -576,15 +560,15 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
   Assert ((!compute_support_points) || (support_points.size() == dofs_per_cell),
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
-  
-  unsigned int n_points=unit_points.size();
+
+unsigned int n_points=unit_points.size();
 
   Point<dim> vertices[GeometryInfo<dim>::vertices_per_cell];
   for (unsigned int l=0; l<GeometryInfo<dim>::vertices_per_cell; ++l)
     vertices[l] = cell->vertex(l);
-  
 
-  if (compute_q_points) 
+
+if (compute_q_points) 
     {
                                       // initialize points to zero
       for (unsigned int i=0; i<n_points; ++i)
@@ -606,7 +590,7 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
        for (unsigned int l=0; l<n_points; ++l) 
          q_points[l] += vertices[j] * shape_values_transform(j, l);
     };
-  
+
 
 /* jacobi matrices: compute d(x)/d(xi) and invert this
    Let M(l) be the inverse of J at the quadrature point l, then
@@ -651,8 +635,8 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
        };
     };
 
-    
-  One last note regarding whether we have to invert M or M transposed: it is
+
+One last note regarding whether we have to invert M or M transposed: it is
   easy to try out, by computing the gradients of a function on a distorted
   cell (just move one vertex) where the nodal values for linear elements
   are one for the moved vertex and zero otherwise. Please also note that
@@ -687,9 +671,9 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
     QTrapez<2> q;
     FEValues<2> fevalues(fe,q,update_gradients);
     fevalues.reinit (dof.begin_active(),b);
-  
-  
-    Vector<double> val(4);
+
+
+Vector<double> val(4);
     val(2) = 1;
 
     vector<Point<2> > grads(4);
@@ -728,8 +712,6 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
 };
 
 
-
-
 /*------------------------------- Explicit Instantiations -------------*/
 
 template class FEQ1Mapping<deal_II_dimension>;
index 1c9f8642fa47369018f189e98b21b20828eaac5d..acc9dede48b2e4a4d2416349ba697a6328c889fc 100644 (file)
@@ -1,7 +1,16 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  q1_mapping.jacobians.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  q1_mapping.jacobians.cc  ---------------------------
 
-// moved from file fe_linear_mapping_jacobians.cc
 
 #include <fe/q1_mapping.h>
 #include <grid/tria_iterator.h>
@@ -10,7 +19,6 @@
 #include <cmath>
 
 
-
 /**
  * This file has been singled out from q1_mapping.cc because the computation
  * of the 3d matrices is so extremely large that it can't be done with
@@ -21,7 +29,6 @@
  */
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -39,7 +46,6 @@ void FEQ1Mapping<1>::compute_jacobian_matrices (const DoFHandler<1>::cell_iterat
 };
 
 
-
 template <>
 void FEQ1Mapping<1>::compute_jacobian_gradients (const DoFHandler<1>::cell_iterator &,
                                                     const vector<Point<1> > &unit_points,
@@ -59,7 +65,6 @@ void FEQ1Mapping<1>::compute_jacobian_gradients (const DoFHandler<1>::cell_itera
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -114,7 +119,6 @@ void FEQ1Mapping<2>::compute_jacobian_matrices (const DoFHandler<2>::cell_iterat
 };
 
 
-
 template <>
 void FEQ1Mapping<2>::compute_jacobian_gradients (const DoFHandler<2>::cell_iterator &cell,
                                                     const vector<Point<2> > &unit_points,
@@ -196,7 +200,6 @@ void FEQ1Mapping<2>::compute_jacobian_gradients (const DoFHandler<2>::cell_itera
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1335,7 +1338,6 @@ void FEQ1Mapping<3>::compute_jacobian_matrices (const DoFHandler<3>::cell_iterat
 };
 
 
-
 template <>
 void FEQ1Mapping<3>::compute_jacobian_gradients (const DoFHandler<3>::cell_iterator &cell,
                                                     const vector<Point<3> > &unit_points,
index e62b5f4f94158bdc5be11adfd51e025e18c8c47b..023896c41ca31d215e2400f50c808e77c6a6da94 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  geometry_info.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  geometry_info.cc  ---------------------------
+
 
 #include <grid/geometry_info.h>
 
index bc023fc627cadeb06df36899793a76380a24c678..bee3e8b1eec9ec9ba1a79ae46f2b68e659f7ad22 100644 (file)
@@ -1,4 +1,15 @@
-/* $Id$ */
+//----------------------------  grid_generator.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  grid_generator.cc  ---------------------------
 
 
 #include <grid/grid_generator.h>
@@ -6,8 +17,6 @@
 #include <cmath>
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -26,7 +35,6 @@ void GridGenerator::hyper_cube<> (Triangulation<1> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_cube_slit<> (Triangulation<1> &,
                                       const double,
@@ -35,7 +43,6 @@ void GridGenerator::hyper_cube_slit<> (Triangulation<1> &,
 };
 
 
-
 template <>
 void GridGenerator::hyper_L<> (Triangulation<1> &,
                               const double,
@@ -44,7 +51,6 @@ void GridGenerator::hyper_L<> (Triangulation<1> &,
 };
 
 
-
 template <>
 void GridGenerator::hyper_ball<> (Triangulation<1> &,
                                  const Point<1> &,
@@ -53,7 +59,6 @@ void GridGenerator::hyper_ball<> (Triangulation<1> &,
 };
 
 
-
 template <>
 void GridGenerator::hyper_shell<> (Triangulation<1> &,
                                   const Point<1> &,
@@ -66,7 +71,6 @@ void GridGenerator::hyper_shell<> (Triangulation<1> &,
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -89,7 +93,6 @@ void GridGenerator::hyper_cube<> (Triangulation<2> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_cube_slit<> (Triangulation<2> &tria,
                                       const double left,
@@ -122,7 +125,6 @@ void GridGenerator::hyper_cube_slit<> (Triangulation<2> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_L<> (Triangulation<2> &tria,
                               const double a,
@@ -155,7 +157,6 @@ void GridGenerator::hyper_L<> (Triangulation<2> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_ball<> (Triangulation<2> &tria,
                                  const Point<2>    &p,
@@ -193,7 +194,6 @@ void GridGenerator::hyper_ball<> (Triangulation<2> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_shell<> (Triangulation<2>   &tria,
                                   const Point<2>     &center,
@@ -283,7 +283,6 @@ void GridGenerator::hyper_cube<> (Triangulation<3> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_cube_slit<> (Triangulation<3> &,
                                       const double,
@@ -292,7 +291,6 @@ void GridGenerator::hyper_cube_slit<> (Triangulation<3> &,
 };
 
 
-
 template <>
 void GridGenerator::hyper_L<> (Triangulation<3> &tria,
                               const double a,
@@ -356,7 +354,6 @@ void GridGenerator::hyper_L<> (Triangulation<3> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_ball<> (Triangulation<3> &tria,
                                  const Point<3> &p,
@@ -415,7 +412,6 @@ void GridGenerator::hyper_ball<> (Triangulation<3> &tria,
 };
 
 
-
 template <>
 void GridGenerator::hyper_shell<> (Triangulation<3>   &,
                                   const Point<3>     &,
@@ -430,8 +426,6 @@ void GridGenerator::hyper_shell<> (Triangulation<3>   &,
 #endif
 
 
-
-
 // explicit instantiations
 // template void GridGenerator::hyper_cube (Triangulation<deal_II_dimension> &,
 //                                      const double,
index 6653a85742f5d5e3d81c702432eba77c37f4012d..e2898672b9230dabfe38b57df0f91715b41c065d 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  grid_in.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  grid_in.cc  ---------------------------
+
 
 #include <grid/grid_in.h>
 #include <grid/tria.h>
 #include <map>
 
 
-
 template <int dim>
 GridIn<dim>::GridIn () :
                tria(0) {};
 
 
-
 template <int dim>
 void GridIn<dim>::attach_triangulation (Triangulation<dim> &t)
 {
@@ -20,7 +30,6 @@ void GridIn<dim>::attach_triangulation (Triangulation<dim> &t)
 };
 
 
-
 template <int dim>
 void GridIn<dim>::read_ucd (istream &in)
 {
@@ -41,9 +50,9 @@ void GridIn<dim>::read_ucd (istream &in)
                                   // put back first character of
                                   // first non-comment line
   in.putback (c);
-  
-  
-  unsigned int n_vertices;
+
+
+unsigned int n_vertices;
   unsigned int n_cells;
   int dummy;
 
@@ -154,6 +163,5 @@ void GridIn<dim>::read_ucd (istream &in)
 };
 
 
-
 //explicit instantiations
 template class GridIn<deal_II_dimension>;
index 3ee7217c76117c8cb0c93b10930686bc71e12de4..59a5d7f600da61195cf7bea446f235af1c3b5f26 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  grid_out.all_dimensions.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  grid_out.all_dimensions.cc  ---------------------------
+
 
 #include <grid/grid_out.h>
 
@@ -10,7 +22,6 @@ GridOut::UcdFlags::UcdFlags (const bool write_preamble,
 {};
 
 
-
 GridOut::GnuplotFlags::GnuplotFlags (const bool write_cell_numbers,
                                     const bool write_level) :
                write_cell_numbers (write_cell_numbers),
@@ -18,7 +29,6 @@ GridOut::GnuplotFlags::GnuplotFlags (const bool write_cell_numbers,
 {};
 
 
-
 GridOut::EpsFlagsBase::EpsFlagsBase (const SizeType     size_type,
                                     const unsigned int size,
                                     const double       line_width) :
@@ -28,7 +38,6 @@ GridOut::EpsFlagsBase::EpsFlagsBase (const SizeType     size_type,
 {};
 
 
-
 // egcs 1.1.2 does not understand this, so I made it inlined in the
 // class declaration
 //
@@ -40,42 +49,36 @@ GridOut::EpsFlagsBase::EpsFlagsBase (const SizeType     size_type,
 // {};
 
 
-
 void GridOut::set_flags (const UcdFlags &flags) 
 {
   ucd_flags = flags;
 };
 
 
-
 void GridOut::set_flags (const GnuplotFlags &flags) 
 {
   gnuplot_flags = flags;
 };
 
 
-
 void GridOut::set_flags (const EpsFlags<1> &flags) 
 {
   eps_flags_1 = flags;
 };
 
 
-
 void GridOut::set_flags (const EpsFlags<2> &flags) 
 {
   eps_flags_2 = flags;
 };
 
 
-
 void GridOut::set_flags (const EpsFlags<3> &flags) 
 {
   eps_flags_3 = flags;
 };
 
 
-
 string GridOut::default_suffix (const OutputFormat output_format) 
 {
   switch (output_format) 
@@ -94,8 +97,6 @@ string GridOut::default_suffix (const OutputFormat output_format)
            return "";
     };
 };
-  
-
 
 
 GridOut::OutputFormat
@@ -116,7 +117,6 @@ GridOut::parse_output_format (const string &format_name)
 };
 
 
-
 string GridOut::get_output_format_names () {
   return "gnuplot|eps";
 };
index 1f9fd183c920f64e18dbbfa01995b12026a50641..033f056497af7f63dbc9cbe1a9105bb7dc69682d 100644 (file)
@@ -1,4 +1,15 @@
-/* $Id$ */
+//----------------------------  grid_out.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  grid_out.cc  ---------------------------
 
 
 #include <base/point.h>
@@ -14,7 +25,6 @@
 #include <cmath>
 
 
-
 template <int dim>
 void GridOut::write_ucd (const Triangulation<dim> &tria,
                         ostream                  &out) 
@@ -42,9 +52,9 @@ void GridOut::write_ucd (const Triangulation<dim> &tria,
          vertices[cell->vertex_index(vertex)] = cell->vertex(vertex);
          ++n_vertices;
        };
-  
 
-                                  // write preamble
+
+// write preamble
   if (ucd_flags.write_preamble)
     {
                                       // block this to have local
@@ -137,7 +147,6 @@ void GridOut::write_ucd (const Triangulation<dim> &tria,
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -149,7 +158,6 @@ unsigned int GridOut::n_boundary_faces (const Triangulation<1> &) const
 #endif
 
 
-
 template <int dim>
 unsigned int GridOut::n_boundary_faces (const Triangulation<dim> &tria) const
 {
@@ -166,7 +174,6 @@ unsigned int GridOut::n_boundary_faces (const Triangulation<dim> &tria) const
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -180,7 +187,6 @@ void GridOut::write_ucd_faces (const Triangulation<1> &,
 #endif
 
 
-
 template <int dim>
 void GridOut::write_ucd_faces (const Triangulation<dim> &tria,
                               const unsigned int        starting_index,
@@ -213,7 +219,6 @@ void GridOut::write_ucd_faces (const Triangulation<dim> &tria,
 };
 
 
-
 template <int dim>
 void GridOut::write_gnuplot (const Triangulation<dim> &tria,
                             ostream                  &out) 
@@ -282,7 +287,6 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
 };
 
 
-
 template <int dim>
 void GridOut::write_eps (const Triangulation<dim> &tria,
                         ostream                  &out) 
@@ -409,10 +413,9 @@ void GridOut::write_eps (const Triangulation<dim> &tria,
       default:
            Assert (false, ExcNotImplemented());
     };
-  
-  
 
-                                  // find out minimum and maximum x and
+
+// find out minimum and maximum x and
                                   // y coordinates to compute offsets
                                   // and scaling factors
   double x_min = tria.begin_active_line()->vertex(0)(0);
@@ -445,9 +448,9 @@ void GridOut::write_eps (const Triangulation<dim> &tria,
                        (eps_flags_base.size_type==EpsFlagsBase::width ?
                         x_max - x_min :
                         y_min - y_max));
-  
-  
-                                  // now write preamble
+
+
+// now write preamble
   if (true) 
     {
                                       // block this to have local
@@ -502,8 +505,6 @@ void GridOut::write_eps (const Triangulation<dim> &tria,
 };
 
 
-
-
 template <int dim>
 void GridOut::write (const Triangulation<dim> &tria,
                     ostream                  &out,
@@ -528,8 +529,6 @@ void GridOut::write (const Triangulation<dim> &tria,
 };
 
 
-
-
 // explicit instantiations. note that write instantiates all the other
 // functions as needed
 template void GridOut::write (const Triangulation<deal_II_dimension> &, ostream &, OutputFormat);
index 0299d848f3fd471dcc71b786543975d0fdbe289e..64767b115c262e33eab9799684f28b77d76d845b 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  intergrid_map.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  intergrid_map.cc  ---------------------------
+
 
 #include <grid/tria.h>
 #include <dofs/dof_handler.h>
@@ -10,7 +22,6 @@
 #include <grid/intergrid_map.h>
 
 
-
 // helper function to aquire the number of levels within a grid
 template <class GridClass>
 unsigned int
@@ -38,18 +49,15 @@ get_n_levels (const Triangulation<dim> &grid)
 };
 
 
-
-
-
 template <template <int> class GridClass, int dim>
 void InterGridMap<GridClass,dim>::make_mapping (const GridClass<dim> &source_grid,
                                                const GridClass<dim> &destination_grid) 
 {
                                   // first delete all contents
   clear ();
-  
 
-                                  // then set up the containers from
+
+// then set up the containers from
                                   // scratch and fill them with end-iterators
   const unsigned int n_levels = get_n_levels(source_grid);
   mapping.resize (n_levels);
@@ -94,7 +102,6 @@ void InterGridMap<GridClass,dim>::make_mapping (const GridClass<dim> &source_gri
 };
 
 
-
 template <template <int> class GridClass, int dim>
 void
 InterGridMap<GridClass,dim>::set_mapping (const cell_iterator &src_cell,
@@ -125,7 +132,6 @@ InterGridMap<GridClass,dim>::set_mapping (const cell_iterator &src_cell,
 };
 
 
-
 template <template <int> class GridClass, int dim>
 void
 InterGridMap<GridClass,dim>::set_entries_to_cell (const cell_iterator &src_cell,
@@ -143,7 +149,6 @@ InterGridMap<GridClass,dim>::set_entries_to_cell (const cell_iterator &src_cell,
 };
 
 
-
 template <template <int> class GridClass, int dim>
 typename InterGridMap<GridClass,dim>::cell_iterator
 InterGridMap<GridClass,dim>::operator [] (const cell_iterator &source_cell) const
@@ -159,7 +164,6 @@ InterGridMap<GridClass,dim>::operator [] (const cell_iterator &source_cell) cons
 };
 
 
-
 template <template <int> class GridClass, int dim>
 void InterGridMap<GridClass,dim>::clear () 
 {
@@ -167,11 +171,9 @@ void InterGridMap<GridClass,dim>::clear ()
 };
 
 
-
-
 // explicit instantiations
 template class InterGridMap<Triangulation, deal_II_dimension>;
 template class InterGridMap<DoFHandler, deal_II_dimension>;
 template class InterGridMap<MGDoFHandler, deal_II_dimension>;
 
-  
+
index be4b0c1bfaf1bb45b75db0b56de88b5024e6d54a..c13536a0b3df8f478607e983971ba20165c54040 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  persistent_tria.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  persistent_tria.cc  ---------------------------
+
 
 #include <grid/persistent_tria.h>
 #include <grid/magic_numbers.h>
@@ -27,13 +39,11 @@ PersistentTriangulation (const PersistentTriangulation<dim> &old_tria) :
 };
 
 
-
 template <int dim>
 PersistentTriangulation<dim>::~PersistentTriangulation () 
 {};
 
 
-
 template <int dim>
 void
 PersistentTriangulation<dim>::execute_coarsening_and_refinement () 
@@ -49,7 +59,6 @@ PersistentTriangulation<dim>::execute_coarsening_and_refinement ()
 };
 
 
-
 template <int dim>
 void
 PersistentTriangulation<dim>::restore () {
@@ -72,7 +81,6 @@ PersistentTriangulation<dim>::restore () {
 };
 
 
-
 template <int dim>
 void
 PersistentTriangulation<dim>::copy_triangulation (const Triangulation<dim> &old_grid) 
@@ -94,7 +102,6 @@ PersistentTriangulation<dim>::create_triangulation (const vector<Point<dim> >
 };
 
 
-
 template <int dim>
 void
 PersistentTriangulation<dim>::write_flags(ostream &out) const
@@ -119,7 +126,6 @@ PersistentTriangulation<dim>::write_flags(ostream &out) const
 }
 
 
-
 template <int dim>
 void
 PersistentTriangulation<dim>::read_flags(istream &in)
index b5c7ce06d1c61e6fc94f7c63d4683049815faef9..de161840b3e52348a24068ec18997da3c43caa52 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1999 */
+//----------------------------  tria.all_dimensions.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tria.all_dimensions.cc  ---------------------------
 
 
 #include <grid/tria.h>
@@ -21,8 +31,6 @@
  */
 
 
-
-
 bool SubCellData::check_consistency (const unsigned int dim) const
 {
   switch (dim) 
@@ -36,8 +44,6 @@ bool SubCellData::check_consistency (const unsigned int dim) const
   return true;
 };
 
-                   
-
 
 void TriangulationLevel<0>::reserve_space (const unsigned int total_cells,
                                           const unsigned int dimension)
@@ -69,8 +75,6 @@ void TriangulationLevel<0>::reserve_space (const unsigned int total_cells,
 };
 
 
-
-
 void TriangulationLevel<0>::monitor_memory (const unsigned int true_dimension) const
 {
 //  Assert (refine_flags.size() == refine_flags.capacity() ||
@@ -92,7 +96,6 @@ void TriangulationLevel<0>::monitor_memory (const unsigned int true_dimension) c
 };
 
 
-
 void TriangulationLevel<1>::reserve_space (const unsigned int new_lines)
 {
   const unsigned int new_size = new_lines +
@@ -138,8 +141,6 @@ void TriangulationLevel<1>::reserve_space (const unsigned int new_lines)
 };
 
 
-
-
 void TriangulationLevel<1>::monitor_memory (const unsigned int true_dimension) const
 {
 //  Assert (lines.lines.size() == lines.lines.capacity() ||
@@ -173,7 +174,6 @@ void TriangulationLevel<1>::monitor_memory (const unsigned int true_dimension) c
 };
 
 
-
 void TriangulationLevel<2>::reserve_space (const unsigned int new_quads)
 {
   const unsigned int new_size = new_quads +
@@ -210,7 +210,6 @@ void TriangulationLevel<2>::reserve_space (const unsigned int new_quads)
 };
 
 
-
 void TriangulationLevel<2>::monitor_memory (const unsigned int true_dimension) const
 {
 //  Assert (quads.quads.size() == quads.quads.capacity() ||
@@ -244,7 +243,6 @@ void TriangulationLevel<2>::monitor_memory (const unsigned int true_dimension) c
 };
 
 
-
 void TriangulationLevel<3>::reserve_space (const unsigned int new_hexes)
 {
   const unsigned int new_size = new_hexes +
@@ -281,7 +279,6 @@ void TriangulationLevel<3>::reserve_space (const unsigned int new_hexes)
 };
 
 
-
 void TriangulationLevel<3>::monitor_memory (const unsigned int true_dimension) const
 {
 //  Assert (hexes.hexes.size() == hexes.hexes.capacity() ||
@@ -315,7 +312,6 @@ void TriangulationLevel<3>::monitor_memory (const unsigned int true_dimension) c
 };
 
 
-
 TriaNumberCache<1>::TriaNumberCache () :
                n_lines (0),
                n_active_lines (0) 
@@ -324,8 +320,6 @@ TriaNumberCache<1>::TriaNumberCache () :
 {};
 
 
-
-
 TriaNumberCache<2>::TriaNumberCache () :
                n_quads (0),
                n_active_quads (0) 
@@ -334,8 +328,6 @@ TriaNumberCache<2>::TriaNumberCache () :
 {};
 
 
-
-
 TriaNumberCache<3>::TriaNumberCache () :
                n_hexes (0),
                n_active_hexes (0) 
index cb0b7f0a04b0dd64b346147b51a97e521e8e14d6..711a1627ef49ebf0777390e9c749d29147bb9c74 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998, 1999 */
+//----------------------------  tria.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tria.cc  ---------------------------
 
 
 #include <grid/tria.h>
 #include <cmath>
 
 
-
 template <int dim>
 const StraightBoundary<dim>& Triangulation<dim>::straight_boundary
 = StraightBoundary<dim>();
 
 
-
-
 template <int dim>
 Triangulation<dim>::Triangulation (const MeshSmoothing smooth_grid) :
                Subscriptor (),
@@ -39,7 +46,6 @@ Triangulation<dim>::Triangulation (const MeshSmoothing smooth_grid) :
 };
 
 
-
 template <int dim>
 Triangulation<dim>::Triangulation (const Triangulation<dim> &) 
                :
@@ -50,7 +56,6 @@ Triangulation<dim>::Triangulation (const Triangulation<dim> &)
 };
 
 
-
 template <int dim>
 Triangulation<dim>::~Triangulation ()
 {
@@ -63,7 +68,6 @@ Triangulation<dim>::~Triangulation ()
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::clear () 
 {
@@ -102,7 +106,6 @@ Triangulation<dim>::set_boundary (const unsigned int number,
 };
 
 
-
 template <int dim>
 const Boundary<dim> &
 Triangulation<dim>::get_boundary (const unsigned int number) const 
@@ -113,8 +116,6 @@ Triangulation<dim>::get_boundary (const unsigned int number) const
 };
 
 
-
-
 /*--------- Put the next functions a bit out-or-order to avoid use before
   --------- explicit specialization, which is not allowed.                */
 
@@ -126,7 +127,6 @@ Triangulation<1>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::end () const {
@@ -145,7 +145,6 @@ Triangulation<2>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::end () const {
@@ -155,7 +154,6 @@ Triangulation<2>::end () const {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -165,7 +163,6 @@ Triangulation<3>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::end () const {
@@ -175,12 +172,9 @@ Triangulation<3>::end () const {
 #endif
 
 
-
-
 /*-----------------------------------------------------------------*/
 
 
-
 template <int dim>
 void Triangulation<dim>::copy_triangulation (const Triangulation<dim> &old_tria)
 {
@@ -213,7 +207,6 @@ void Triangulation<dim>::copy_triangulation (const Triangulation<dim> &old_tria)
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -265,7 +258,7 @@ void Triangulation<1>::create_triangulation (const vector<Point<1> >    &v,
     };
 
 
-                                  // some security tests
+// some security tests
   unsigned int boundary_nodes = 0;
   for (unsigned int i=0; i<lines_at_vertex.size(); ++i)
     switch (lines_at_vertex[i].size()) 
@@ -284,7 +277,7 @@ void Triangulation<1>::create_triangulation (const vector<Point<1> >    &v,
   AssertThrow (boundary_nodes == 2, ExcInternalError());
 
 
-                                  // update neighborship info
+// update neighborship info
   active_line_iterator line = begin_active_line ();
                                   // for all lines
   for (; line!=end(); ++line)
@@ -317,14 +310,13 @@ void Triangulation<1>::create_triangulation (const vector<Point<1> >    &v,
        };
 
 
-                                  // re-compute numbers of lines, etc
+// re-compute numbers of lines, etc
   update_number_cache ();  
 };
 
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -346,8 +338,8 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
                                   // may need to change entries
   vector<CellData<2> > cells(c);
 
-  
-                                  // make up a list of the needed lines
+
+// make up a list of the needed lines
                                   // each line is a pair of vertices. The list
                                   // is kept sorted and it is guaranteed
                                   // that each line is inserted only once.
@@ -408,9 +400,9 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
                                             // rotation
            break;
          };
-      
-      
-      for (unsigned int line=0; line<4; ++line)
+
+
+for (unsigned int line=0; line<4; ++line)
        {
                                           // assert that the line was not
                                           // already inserted in reverse
@@ -445,9 +437,9 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
          needed_lines[line_vertices[line]] = end_line();
        };
     };
-  
 
-                                  // check the every vertex has
+
+// check the every vertex has
                                   // at least two adjacent lines
   if (true) 
     {
@@ -489,7 +481,7 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
     };
 
 
-                                  // store for each line index
+// store for each line index
                                   // the adjacent cells
   map<int,vector<cell_iterator> > adjacent_cells;
 
@@ -531,9 +523,9 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
                  ExcInternalErrorOnCell(c));
        };
     };
-  
 
-  for (line_iterator line=begin_line(); line!=end_line(); ++line) 
+
+for (line_iterator line=begin_line(); line!=end_line(); ++line) 
     {
       const unsigned int n_adj_cells = adjacent_cells[line->index()].size();
                                       // assert that every line has one or
@@ -590,10 +582,7 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
     };
 
 
-
-  
-
-                                  // finally update neighborship info
+// finally update neighborship info
   for (cell_iterator cell=begin(); cell!=end(); ++cell)
     for (unsigned int side=0; side<4; ++side)
       if (adjacent_cells[cell->line(side)->index()][0] == cell)
@@ -612,7 +601,7 @@ void Triangulation<2>::create_triangulation (const vector<Point<2> >    &v,
                            adjacent_cells[cell->line(side)->index()][0]);
 
 
-                                  // re-compute numbers of lines, etc
+// re-compute numbers of lines, etc
   update_number_cache ();  
 };
 
@@ -652,7 +641,6 @@ struct QuadComparator {
 };
 
 
-
 template <>
 void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
                                             const vector<CellData<3> > &c,
@@ -742,9 +730,9 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
          needed_lines[line_vertices[line]] = end_line();
        };
     };
-  
 
-                                  /////////////////////////////////
+
+/////////////////////////////////
                                   // now for some sanity-checks:
                                   //
                                   // check the every vertex has
@@ -768,7 +756,7 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
     };
 
 
-                                  ///////////////////////////////////
+///////////////////////////////////
                                   // actually set up data structures
                                   // for the lines
                                   // reserve enough space
@@ -795,7 +783,7 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
     };
 
 
-                                  ///////////////////////////////////////////
+///////////////////////////////////////////
                                   // make up the quads of this triangulation
                                   //
                                   // same thing: the iterators are set
@@ -888,9 +876,9 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
                                         // nothing bad happens here
          needed_quads[faces[quad]] = end_quad();
     };
-  
 
-                                  /////////////////////////////////
+
+/////////////////////////////////
                                   // enter the resulting quads into
                                   // the arrays of the Triangulation
                                   //
@@ -1047,9 +1035,9 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
                  ExcInternalErrorOnCell(c));
        };
     };
-  
 
-                                  /////////////////////////////////////////
+
+/////////////////////////////////////////
                                   // find those quads which are at the
                                   // boundary and mark them appropriately
   for (quad_iterator quad=begin_quad(); quad!=end_quad(); ++quad)
@@ -1086,9 +1074,9 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
     if (quad->at_boundary())
       for (unsigned int l=0; l<4; ++l)
        quad->line(l)->set_boundary_indicator (0);
-  
 
-                                  ///////////////////////////////////////
+
+///////////////////////////////////////
                                   // now set boundary indicators
                                   // where given
                                   //
@@ -1096,9 +1084,9 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
   AssertThrow ((subcelldata.boundary_lines.size() == 0) &&
               (subcelldata.boundary_quads.size() == 0),
               ExcInternalError());
-  
 
-                                  /////////////////////////////////////////
+
+/////////////////////////////////////////
                                   // finally update neighborship info
   for (cell_iterator cell=begin(); cell!=end(); ++cell)
     for (unsigned int face=0; face<6; ++face)
@@ -1118,15 +1106,13 @@ void Triangulation<3>::create_triangulation (const vector<Point<3> >    &v,
                            adjacent_cells[cell->quad(face)->index()][0]);
 
 
-                                  // re-compute numbers of lines, etc
+// re-compute numbers of lines, etc
   update_number_cache ();  
 };
 
 #endif
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1177,7 +1163,7 @@ void Triangulation<1>::distort_random (const double factor,
     };
 
 
-  const unsigned int n_vertices = vertices.size();
+const unsigned int n_vertices = vertices.size();
   Point<dim> shift_vector;
   
   for (unsigned int vertex=0; vertex<n_vertices; ++vertex) 
@@ -1203,7 +1189,6 @@ void Triangulation<1>::distort_random (const double factor,
 #endif
 
 
-
 template <int dim>
 void Triangulation<dim>::distort_random (const double factor,
                                         const bool   keep_boundary) {
@@ -1251,7 +1236,7 @@ void Triangulation<dim>::distort_random (const double factor,
     };
 
 
-  const unsigned int n_vertices = vertices.size();
+const unsigned int n_vertices = vertices.size();
   Point<dim> shift_vector;
   
   for (unsigned int vertex=0; vertex<n_vertices; ++vertex) 
@@ -1273,8 +1258,8 @@ void Triangulation<dim>::distort_random (const double factor,
       vertices[vertex] += shift_vector;
     };
 
-  
-                                  // finally correct hanging nodes
+
+// finally correct hanging nodes
                                   // again. The following is not
                                   // necessary for 1D
   active_cell_iterator cell = begin_active(),
@@ -1302,8 +1287,6 @@ void Triangulation<dim>::distort_random (const double factor,
 };
 
 
-
-
 template <int dim>
 void Triangulation<dim>::set_all_refine_flags () {
   active_cell_iterator cell = begin_active(),
@@ -1317,7 +1300,6 @@ void Triangulation<dim>::set_all_refine_flags () {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::refine_global (const unsigned int times) {
   for (unsigned int i=0; i<times; ++i)
@@ -1328,7 +1310,6 @@ void Triangulation<dim>::refine_global (const unsigned int times) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_refine_flags (vector<bool> &v) const {
   v.resize (n_active_cells(), false);
@@ -1340,7 +1321,6 @@ void Triangulation<dim>::save_refine_flags (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_refine_flags (ostream &out) const {
   vector<bool> v;
@@ -1350,7 +1330,6 @@ void Triangulation<dim>::save_refine_flags (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_refine_flags (istream &in) {
   vector<bool> v;
@@ -1360,7 +1339,6 @@ void Triangulation<dim>::load_refine_flags (istream &in) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_refine_flags (const vector<bool> &v) {
   Assert (v.size() == n_active_cells(), ExcGridReadError());
@@ -1376,7 +1354,6 @@ void Triangulation<dim>::load_refine_flags (const vector<bool> &v) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_coarsen_flags (vector<bool> &v) const {
   v.resize (n_active_cells(), false);
@@ -1388,7 +1365,6 @@ void Triangulation<dim>::save_coarsen_flags (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_coarsen_flags (ostream &out) const {
   vector<bool> v;
@@ -1398,7 +1374,6 @@ void Triangulation<dim>::save_coarsen_flags (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_coarsen_flags (istream &in) {
   vector<bool> v;
@@ -1408,7 +1383,6 @@ void Triangulation<dim>::load_coarsen_flags (istream &in) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_coarsen_flags (const vector<bool> &v) {
   Assert (v.size() == n_active_cells(), ExcGridReadError());
@@ -1424,7 +1398,6 @@ void Triangulation<dim>::load_coarsen_flags (const vector<bool> &v) {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1436,7 +1409,6 @@ void Triangulation<1>::clear_user_pointers () {
 };
 
 
-
 template <>
 void Triangulation<1>::clear_user_flags () {
   cell_iterator cell = begin(),
@@ -1464,7 +1436,6 @@ void Triangulation<2>::clear_user_pointers () {
 };
 
 
-
 template <>
 void Triangulation<2>::clear_user_flags () {
   line_iterator line = begin_line(),
@@ -1482,8 +1453,6 @@ void Triangulation<2>::clear_user_flags () {
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1505,7 +1474,6 @@ void Triangulation<3>::clear_user_pointers () {
 };
 
 
-
 template <>
 void Triangulation<3>::clear_user_flags () {
   line_iterator line = begin_line(),
@@ -1528,8 +1496,6 @@ void Triangulation<3>::clear_user_flags () {
 #endif
 
 
-
-
 template <int dim>
 void Triangulation<dim>::save_user_flags (ostream &out) const {
   save_user_flags_line (out);
@@ -1545,7 +1511,6 @@ void Triangulation<dim>::save_user_flags (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_user_flags (vector<bool> &v) const {
                                   // clear vector and append
@@ -1574,7 +1539,6 @@ void Triangulation<dim>::save_user_flags (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags (istream &in)
 {
@@ -1591,7 +1555,6 @@ void Triangulation<dim>::load_user_flags (istream &in)
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags (const vector<bool> &v)
 {
@@ -1627,7 +1590,6 @@ void Triangulation<dim>::load_user_flags (const vector<bool> &v)
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_line (vector<bool> &v) const {
   v.resize (n_lines(), false);
@@ -1639,7 +1601,6 @@ void Triangulation<dim>::save_user_flags_line (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_line (ostream &out) const {
   vector<bool> v;
@@ -1649,7 +1610,6 @@ void Triangulation<dim>::save_user_flags_line (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_line (istream &in) {
   vector<bool> v;
@@ -1659,7 +1619,6 @@ void Triangulation<dim>::load_user_flags_line (istream &in) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_line (const vector<bool> &v) {
   Assert (v.size() == n_lines(), ExcGridReadError());
@@ -1675,7 +1634,6 @@ void Triangulation<dim>::load_user_flags_line (const vector<bool> &v) {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1684,7 +1642,6 @@ void Triangulation<1>::save_user_flags_quad (ostream &) const {
 };
 
 
-
 template <>
 void Triangulation<1>::save_user_flags_quad (vector<bool> &) const {
   Assert (false, ExcFunctionNotUseful());
@@ -1709,7 +1666,6 @@ void Triangulation<1>::save_user_flags_hex (ostream &) const {
 };
 
 
-
 template <>
 void Triangulation<1>::save_user_flags_hex (vector<bool> &) const {
   Assert (false, ExcFunctionNotUseful());
@@ -1730,8 +1686,6 @@ void Triangulation<1>::load_user_flags_hex (const vector<bool> &) {
 #endif
 
 
-
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_quad (vector<bool> &v) const {
   v.resize (n_quads(), false);
@@ -1743,7 +1697,6 @@ void Triangulation<dim>::save_user_flags_quad (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_quad (ostream &out) const {
   vector<bool> v;
@@ -1753,7 +1706,6 @@ void Triangulation<dim>::save_user_flags_quad (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_quad (istream &in) {
   vector<bool> v;
@@ -1763,7 +1715,6 @@ void Triangulation<dim>::load_user_flags_quad (istream &in) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_quad (const vector<bool> &v) {
   Assert (v.size() == n_quads(), ExcGridReadError());
@@ -1779,7 +1730,6 @@ void Triangulation<dim>::load_user_flags_quad (const vector<bool> &v) {
 };
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -1788,7 +1738,6 @@ void Triangulation<2>::save_user_flags_hex (ostream &) const {
 };
 
 
-
 template <>
 void Triangulation<2>::save_user_flags_hex (vector<bool> &) const {
   Assert (false, ExcFunctionNotUseful());
@@ -1810,8 +1759,6 @@ void Triangulation<2>::load_user_flags_hex (const vector<bool> &) {
 #endif
 
 
-
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_hex (vector<bool> &v) const {
   v.resize (n_hexs(), false);
@@ -1823,7 +1770,6 @@ void Triangulation<dim>::save_user_flags_hex (vector<bool> &v) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::save_user_flags_hex (ostream &out) const {
   vector<bool> v;
@@ -1833,7 +1779,6 @@ void Triangulation<dim>::save_user_flags_hex (ostream &out) const {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_hex (istream &in) {
   vector<bool> v;
@@ -1843,7 +1788,6 @@ void Triangulation<dim>::load_user_flags_hex (istream &in) {
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::load_user_flags_hex (const vector<bool> &v) {
   Assert (v.size() == n_hexs(), ExcGridReadError());
@@ -1859,7 +1803,6 @@ void Triangulation<dim>::load_user_flags_hex (const vector<bool> &v) {
 };
 
 
-
 /*------------------------ Iterator functions ------------------------*/
 
 
@@ -1872,7 +1815,6 @@ Triangulation<1>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::begin_active (const unsigned int level) const {
@@ -1880,7 +1822,6 @@ Triangulation<1>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::last_raw () const {
@@ -1888,7 +1829,6 @@ Triangulation<1>::last_raw () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::last_raw (const unsigned int level) const {
@@ -1896,7 +1836,6 @@ Triangulation<1>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::cell_iterator
 Triangulation<1>::last () const {
@@ -1904,7 +1843,6 @@ Triangulation<1>::last () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::cell_iterator
 Triangulation<1>::last (const unsigned int level) const {
@@ -1912,7 +1850,6 @@ Triangulation<1>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::last_active () const {
@@ -1920,7 +1857,6 @@ Triangulation<1>::last_active () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::last_active (const unsigned int level) const {
@@ -1928,7 +1864,6 @@ Triangulation<1>::last_active (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_face_iterator
 Triangulation<1>::begin_raw_face (const unsigned int) const {
@@ -1937,7 +1872,6 @@ Triangulation<1>::begin_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::face_iterator
 Triangulation<1>::begin_face (const unsigned int) const {
@@ -1946,7 +1880,6 @@ Triangulation<1>::begin_face (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_face_iterator
 Triangulation<1>::begin_active_face (const unsigned int) const {
@@ -1955,7 +1888,6 @@ Triangulation<1>::begin_active_face (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_face_iterator
 Triangulation<1>::end_face () const {
@@ -1964,7 +1896,6 @@ Triangulation<1>::end_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_face_iterator
 Triangulation<1>::last_raw_face () const {
@@ -1973,7 +1904,6 @@ Triangulation<1>::last_raw_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_face_iterator
 Triangulation<1>::last_raw_face (const unsigned int) const {
@@ -1982,7 +1912,6 @@ Triangulation<1>::last_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::face_iterator
 Triangulation<1>::last_face () const {
@@ -1991,7 +1920,6 @@ Triangulation<1>::last_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::face_iterator
 Triangulation<1>::last_face (const unsigned int) const {
@@ -2000,7 +1928,6 @@ Triangulation<1>::last_face (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_face_iterator
 Triangulation<1>::last_active_face () const {
@@ -2009,7 +1936,6 @@ Triangulation<1>::last_active_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_face_iterator
 Triangulation<1>::last_active_face (const unsigned int) const {
@@ -2026,7 +1952,6 @@ Triangulation<1>::begin_raw_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::quad_iterator
 Triangulation<1>::begin_quad (const unsigned int) const {
@@ -2035,7 +1960,6 @@ Triangulation<1>::begin_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_quad_iterator
 Triangulation<1>::begin_active_quad (const unsigned int) const {
@@ -2044,7 +1968,6 @@ Triangulation<1>::begin_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_quad_iterator
 Triangulation<1>::end_quad () const {
@@ -2053,7 +1976,6 @@ Triangulation<1>::end_quad () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_quad_iterator
 Triangulation<1>::last_raw_quad (const unsigned int) const {
@@ -2062,7 +1984,6 @@ Triangulation<1>::last_raw_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_quad_iterator
 Triangulation<1>::last_raw_quad () const {
@@ -2071,7 +1992,6 @@ Triangulation<1>::last_raw_quad () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::quad_iterator
 Triangulation<1>::last_quad (const unsigned int) const {
@@ -2080,7 +2000,6 @@ Triangulation<1>::last_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::quad_iterator
 Triangulation<1>::last_quad () const {
@@ -2089,7 +2008,6 @@ Triangulation<1>::last_quad () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_quad_iterator
 Triangulation<1>::last_active_quad (const unsigned int) const {
@@ -2098,7 +2016,6 @@ Triangulation<1>::last_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_quad_iterator
 Triangulation<1>::last_active_quad () const {
@@ -2107,7 +2024,6 @@ Triangulation<1>::last_active_quad () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_hex_iterator
 Triangulation<1>::begin_raw_hex (const unsigned int) const {
@@ -2116,7 +2032,6 @@ Triangulation<1>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::hex_iterator
 Triangulation<1>::begin_hex (const unsigned int) const {
@@ -2125,7 +2040,6 @@ Triangulation<1>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_hex_iterator
 Triangulation<1>::begin_active_hex (const unsigned int) const {
@@ -2134,7 +2048,6 @@ Triangulation<1>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_hex_iterator
 Triangulation<1>::end_hex () const {
@@ -2143,7 +2056,6 @@ Triangulation<1>::end_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_hex_iterator
 Triangulation<1>::last_raw_hex (const unsigned int) const {
@@ -2152,7 +2064,6 @@ Triangulation<1>::last_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::raw_hex_iterator
 Triangulation<1>::last_raw_hex () const {
@@ -2161,7 +2072,6 @@ Triangulation<1>::last_raw_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::hex_iterator
 Triangulation<1>::last_hex (const unsigned int) const {
@@ -2170,7 +2080,6 @@ Triangulation<1>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::hex_iterator
 Triangulation<1>::last_hex () const {
@@ -2179,7 +2088,6 @@ Triangulation<1>::last_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_hex_iterator
 Triangulation<1>::last_active_hex (const unsigned int) const {
@@ -2188,7 +2096,6 @@ Triangulation<1>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<1>::active_hex_iterator
 Triangulation<1>::last_active_hex () const {
@@ -2199,8 +2106,6 @@ Triangulation<1>::last_active_hex () const {
 #endif
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -2210,7 +2115,6 @@ Triangulation<2>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::begin_active (const unsigned int level) const {
@@ -2218,7 +2122,6 @@ Triangulation<2>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::last_raw () const {
@@ -2226,7 +2129,6 @@ Triangulation<2>::last_raw () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::last_raw (const unsigned int level) const {
@@ -2234,7 +2136,6 @@ Triangulation<2>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::cell_iterator
 Triangulation<2>::last () const {
@@ -2242,7 +2143,6 @@ Triangulation<2>::last () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::cell_iterator
 Triangulation<2>::last (const unsigned int level) const {
@@ -2250,7 +2150,6 @@ Triangulation<2>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::last_active () const {
@@ -2258,7 +2157,6 @@ Triangulation<2>::last_active () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::last_active (const unsigned int level) const {
@@ -2266,11 +2164,6 @@ Triangulation<2>::last_active (const unsigned int level) const {
 };
 
 
-
-
-
-
-
 template <>
 TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::begin_raw_face (const unsigned int level) const {
@@ -2278,7 +2171,6 @@ Triangulation<2>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::begin_face (const unsigned int level) const {
@@ -2286,7 +2178,6 @@ Triangulation<2>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::begin_active_face (const unsigned int level) const {
@@ -2294,7 +2185,6 @@ Triangulation<2>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::end_face () const {
@@ -2302,7 +2192,6 @@ Triangulation<2>::end_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::last_raw_face () const {
@@ -2310,7 +2199,6 @@ Triangulation<2>::last_raw_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::last_raw_face (const unsigned int level) const {
@@ -2318,7 +2206,6 @@ Triangulation<2>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::last_face () const {
@@ -2326,7 +2213,6 @@ Triangulation<2>::last_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::last_face (const unsigned int level) const {
@@ -2334,7 +2220,6 @@ Triangulation<2>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::last_active_face () const {
@@ -2342,7 +2227,6 @@ Triangulation<2>::last_active_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::last_active_face (const unsigned int level) const {
@@ -2358,7 +2242,6 @@ Triangulation<2>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::hex_iterator
 Triangulation<2>::begin_hex (const unsigned int) const {
@@ -2367,7 +2250,6 @@ Triangulation<2>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_hex_iterator
 Triangulation<2>::begin_active_hex (const unsigned int) const {
@@ -2376,7 +2258,6 @@ Triangulation<2>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_hex_iterator
 Triangulation<2>::end_hex () const {
@@ -2385,7 +2266,6 @@ Triangulation<2>::end_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_hex_iterator
 Triangulation<2>::last_raw_hex (const unsigned int) const {
@@ -2394,7 +2274,6 @@ Triangulation<2>::last_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::raw_hex_iterator
 Triangulation<2>::last_raw_hex () const {
@@ -2403,7 +2282,6 @@ Triangulation<2>::last_raw_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::hex_iterator
 Triangulation<2>::last_hex (const unsigned int) const {
@@ -2412,7 +2290,6 @@ Triangulation<2>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::hex_iterator
 Triangulation<2>::last_hex () const {
@@ -2421,7 +2298,6 @@ Triangulation<2>::last_hex () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_hex_iterator
 Triangulation<2>::last_active_hex (const unsigned int) const {
@@ -2430,7 +2306,6 @@ Triangulation<2>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<2>::active_hex_iterator
 Triangulation<2>::last_active_hex () const {
@@ -2442,7 +2317,6 @@ Triangulation<2>::last_active_hex () const {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -2452,7 +2326,6 @@ Triangulation<3>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::begin_active (const unsigned int level) const {
@@ -2460,7 +2333,6 @@ Triangulation<3>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::last_raw () const {
@@ -2468,7 +2340,6 @@ Triangulation<3>::last_raw () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::last_raw (const unsigned int level) const {
@@ -2476,7 +2347,6 @@ Triangulation<3>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::cell_iterator
 Triangulation<3>::last () const {
@@ -2484,7 +2354,6 @@ Triangulation<3>::last () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::cell_iterator
 Triangulation<3>::last (const unsigned int level) const {
@@ -2492,7 +2361,6 @@ Triangulation<3>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::last_active () const {
@@ -2500,7 +2368,6 @@ Triangulation<3>::last_active () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::last_active (const unsigned int level) const {
@@ -2508,11 +2375,6 @@ Triangulation<3>::last_active (const unsigned int level) const {
 };
 
 
-
-
-
-
-
 template <>
 TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::begin_raw_face (const unsigned int level) const {
@@ -2520,7 +2382,6 @@ Triangulation<3>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::begin_face (const unsigned int level) const {
@@ -2528,7 +2389,6 @@ Triangulation<3>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::begin_active_face (const unsigned int level) const {
@@ -2536,7 +2396,6 @@ Triangulation<3>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::end_face () const {
@@ -2544,7 +2403,6 @@ Triangulation<3>::end_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::last_raw_face () const {
@@ -2552,7 +2410,6 @@ Triangulation<3>::last_raw_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::last_raw_face (const unsigned int level) const {
@@ -2560,7 +2417,6 @@ Triangulation<3>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::last_face () const {
@@ -2568,7 +2424,6 @@ Triangulation<3>::last_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::last_face (const unsigned int level) const {
@@ -2576,7 +2431,6 @@ Triangulation<3>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::last_active_face () const {
@@ -2584,7 +2438,6 @@ Triangulation<3>::last_active_face () const {
 };
 
 
-
 template <>
 TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::last_active_face (const unsigned int level) const {
@@ -2592,12 +2445,9 @@ Triangulation<3>::last_active_face (const unsigned int level) const {
 };
 
 
-
 #endif
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::begin_raw_line (unsigned int level) const {
@@ -2612,8 +2462,6 @@ Triangulation<dim>::begin_raw_line (unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::begin_raw_quad (unsigned int level) const {
@@ -2628,7 +2476,6 @@ Triangulation<dim>::begin_raw_quad (unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::begin_raw_hex (unsigned int level) const {
@@ -2643,8 +2490,6 @@ Triangulation<dim>::begin_raw_hex (unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::line_iterator
 Triangulation<dim>::begin_line (unsigned int level) const {
@@ -2659,8 +2504,6 @@ Triangulation<dim>::begin_line (unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::quad_iterator
 Triangulation<dim>::begin_quad (unsigned int level) const {
@@ -2675,7 +2518,6 @@ Triangulation<dim>::begin_quad (unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::hex_iterator
 Triangulation<dim>::begin_hex (unsigned int level) const {
@@ -2690,8 +2532,6 @@ Triangulation<dim>::begin_hex (unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_line_iterator
 Triangulation<dim>::begin_active_line (unsigned int level) const {
@@ -2706,7 +2546,6 @@ Triangulation<dim>::begin_active_line (unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_quad_iterator
 Triangulation<dim>::begin_active_quad (unsigned int level) const {
@@ -2721,7 +2560,6 @@ Triangulation<dim>::begin_active_quad (unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_hex_iterator
 Triangulation<dim>::begin_active_hex (unsigned int level) const {
@@ -2736,7 +2574,6 @@ Triangulation<dim>::begin_active_hex (unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::end_line () const {
@@ -2746,8 +2583,6 @@ Triangulation<dim>::end_line () const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::end_quad () const {
@@ -2757,7 +2592,6 @@ Triangulation<dim>::end_quad () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::end_hex () const {
@@ -2767,7 +2601,6 @@ Triangulation<dim>::end_hex () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::last_raw_line (const unsigned int level) const {
@@ -2781,7 +2614,6 @@ Triangulation<dim>::last_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::last_raw_quad (const unsigned int level) const {
@@ -2796,7 +2628,6 @@ Triangulation<dim>::last_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::last_raw_hex (const unsigned int level) const {
@@ -2811,7 +2642,6 @@ Triangulation<dim>::last_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::last_raw_line () const {
@@ -2819,8 +2649,6 @@ Triangulation<dim>::last_raw_line () const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::last_raw_quad () const {
@@ -2828,7 +2656,6 @@ Triangulation<dim>::last_raw_quad () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::last_raw_hex () const {
@@ -2836,7 +2663,6 @@ Triangulation<dim>::last_raw_hex () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::line_iterator
 Triangulation<dim>::last_line (const unsigned int level) const {
@@ -2851,7 +2677,6 @@ Triangulation<dim>::last_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::quad_iterator
 Triangulation<dim>::last_quad (const unsigned int level) const {
@@ -2866,7 +2691,6 @@ Triangulation<dim>::last_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::hex_iterator
 Triangulation<dim>::last_hex (const unsigned int level) const {
@@ -2881,7 +2705,6 @@ Triangulation<dim>::last_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::line_iterator
 Triangulation<dim>::last_line () const {
@@ -2889,7 +2712,6 @@ Triangulation<dim>::last_line () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::quad_iterator
 Triangulation<dim>::last_quad () const {
@@ -2897,7 +2719,6 @@ Triangulation<dim>::last_quad () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::hex_iterator
 Triangulation<dim>::last_hex () const {
@@ -2905,8 +2726,6 @@ Triangulation<dim>::last_hex () const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_line_iterator
 Triangulation<dim>::last_active_line (const unsigned int level) const {
@@ -2921,7 +2740,6 @@ Triangulation<dim>::last_active_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_quad_iterator
 Triangulation<dim>::last_active_quad (const unsigned int level) const {
@@ -2936,7 +2754,6 @@ Triangulation<dim>::last_active_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_hex_iterator
 Triangulation<dim>::last_active_hex (const unsigned int level) const {
@@ -2951,8 +2768,6 @@ Triangulation<dim>::last_active_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_line_iterator
 Triangulation<dim>::last_active_line () const {
@@ -2960,8 +2775,6 @@ Triangulation<dim>::last_active_line () const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_quad_iterator
 Triangulation<dim>::last_active_quad () const {
@@ -2969,7 +2782,6 @@ Triangulation<dim>::last_active_quad () const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_hex_iterator
 Triangulation<dim>::last_active_hex () const {
@@ -2977,8 +2789,6 @@ Triangulation<dim>::last_active_hex () const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_cell_iterator
 Triangulation<dim>::end_raw (const unsigned int level) const {
@@ -2988,7 +2798,6 @@ Triangulation<dim>::end_raw (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::cell_iterator
 Triangulation<dim>::end (const unsigned int level) const {
@@ -2998,7 +2807,6 @@ Triangulation<dim>::end (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_cell_iterator
 Triangulation<dim>::end_active (const unsigned int level) const {
@@ -3008,7 +2816,6 @@ Triangulation<dim>::end_active (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_face_iterator
 Triangulation<dim>::end_raw_face (const unsigned int level) const {
@@ -3018,7 +2825,6 @@ Triangulation<dim>::end_raw_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::face_iterator
 Triangulation<dim>::end_face (const unsigned int level) const {
@@ -3028,7 +2834,6 @@ Triangulation<dim>::end_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_face_iterator
 Triangulation<dim>::end_active_face (const unsigned int level) const {
@@ -3038,7 +2843,6 @@ Triangulation<dim>::end_active_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::end_raw_line (const unsigned int level) const {
@@ -3048,7 +2852,6 @@ Triangulation<dim>::end_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::line_iterator
 Triangulation<dim>::end_line (const unsigned int level) const {
@@ -3058,7 +2861,6 @@ Triangulation<dim>::end_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_line_iterator
 Triangulation<dim>::end_active_line (const unsigned int level) const {
@@ -3068,8 +2870,6 @@ Triangulation<dim>::end_active_line (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::end_raw_quad (const unsigned int level) const {
@@ -3079,7 +2879,6 @@ Triangulation<dim>::end_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::quad_iterator
 Triangulation<dim>::end_quad (const unsigned int level) const {
@@ -3089,7 +2888,6 @@ Triangulation<dim>::end_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_quad_iterator
 Triangulation<dim>::end_active_quad (const unsigned int level) const {
@@ -3099,9 +2897,6 @@ Triangulation<dim>::end_active_quad (const unsigned int level) const {
 };
 
 
-
-
-
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::end_raw_hex (const unsigned int level) const {
@@ -3111,7 +2906,6 @@ Triangulation<dim>::end_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::hex_iterator
 Triangulation<dim>::end_hex (const unsigned int level) const {
@@ -3121,7 +2915,6 @@ Triangulation<dim>::end_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename TriaDimensionInfo<dim>::active_hex_iterator
 Triangulation<dim>::end_active_hex (const unsigned int level) const {
@@ -3131,9 +2924,6 @@ Triangulation<dim>::end_active_hex (const unsigned int level) const {
 };
 
 
-
-
-
 template <int dim>
 unsigned int Triangulation<dim>::n_cells () const {
   unsigned int n=0;
@@ -3143,7 +2933,6 @@ unsigned int Triangulation<dim>::n_cells () const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_cells () const {
   unsigned int n=0;
@@ -3153,7 +2942,6 @@ unsigned int Triangulation<dim>::n_active_cells () const {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -3170,7 +2958,6 @@ unsigned int Triangulation<1>::n_cells (const unsigned int level) const {
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -3179,7 +2966,6 @@ unsigned int Triangulation<2>::n_cells (const unsigned int level) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<2>::n_active_cells (const unsigned int level) const {
   return n_active_quads (level);
@@ -3188,7 +2974,6 @@ unsigned int Triangulation<2>::n_active_cells (const unsigned int level) const {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -3197,7 +2982,6 @@ unsigned int Triangulation<3>::n_cells (const unsigned int level) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<3>::n_active_cells (const unsigned int level) const {
   return n_active_hexs (level);
@@ -3206,15 +2990,12 @@ unsigned int Triangulation<3>::n_active_cells (const unsigned int level) const {
 #endif
 
 
-
-
 template <int dim>
 unsigned int Triangulation<dim>::n_lines () const {
   return number_cache.n_lines;
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_lines (const unsigned int level) const {
   Assert (level < number_cache.n_lines_level.size(),
@@ -3224,14 +3005,12 @@ unsigned int Triangulation<dim>::n_lines (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_lines () const {
   return number_cache.n_active_lines;
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_lines (const unsigned int level) const {
   Assert (level < number_cache.n_lines_level.size(),
@@ -3241,7 +3020,6 @@ unsigned int Triangulation<dim>::n_active_lines (const unsigned int level) const
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -3251,7 +3029,6 @@ unsigned int Triangulation<1>::n_quads () const {
 };
 
 
-
 template <>
 unsigned int Triangulation<1>::n_quads (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3259,7 +3036,6 @@ unsigned int Triangulation<1>::n_quads (const unsigned int) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<1>::n_active_quads (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3283,7 +3059,6 @@ unsigned int Triangulation<dim>::n_quads () const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_quads (const unsigned int level) const {
   Assert (level < number_cache.n_quads_level.size(),
@@ -3293,14 +3068,12 @@ unsigned int Triangulation<dim>::n_quads (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_quads () const {
   return number_cache.n_active_quads;
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_quads (const unsigned int level) const {
   Assert (level < number_cache.n_quads_level.size(),
@@ -3310,7 +3083,6 @@ unsigned int Triangulation<dim>::n_active_quads (const unsigned int level) const
 };
 
 
-
 #if deal_II_dimension < 3
 
 template <>
@@ -3320,7 +3092,6 @@ unsigned int Triangulation<1>::n_hexs () const {
 };
 
 
-
 template <>
 unsigned int Triangulation<1>::n_hexs (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3328,7 +3099,6 @@ unsigned int Triangulation<1>::n_hexs (const unsigned int) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<1>::n_active_hexs () const {
   Assert (false, ExcFunctionNotUseful());
@@ -3336,7 +3106,6 @@ unsigned int Triangulation<1>::n_active_hexs () const {
 };
 
 
-
 template <>
 unsigned int Triangulation<1>::n_active_hexs (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3344,7 +3113,6 @@ unsigned int Triangulation<1>::n_active_hexs (const unsigned int) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<2>::n_hexs () const {
   Assert (false, ExcFunctionNotUseful());
@@ -3352,7 +3120,6 @@ unsigned int Triangulation<2>::n_hexs () const {
 };
 
 
-
 template <>
 unsigned int Triangulation<2>::n_hexs (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3360,7 +3127,6 @@ unsigned int Triangulation<2>::n_hexs (const unsigned int) const {
 };
 
 
-
 template <>
 unsigned int Triangulation<2>::n_active_hexs () const {
   Assert (false, ExcFunctionNotUseful());
@@ -3368,7 +3134,6 @@ unsigned int Triangulation<2>::n_active_hexs () const {
 };
 
 
-
 template <>
 unsigned int Triangulation<2>::n_active_hexs (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
@@ -3384,7 +3149,6 @@ unsigned int Triangulation<dim>::n_hexs () const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_hexs (const unsigned int level) const {
   Assert (level < number_cache.n_hexes_level.size(),
@@ -3394,14 +3158,12 @@ unsigned int Triangulation<dim>::n_hexs (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_hexs () const {
   return number_cache.n_active_hexes;
 };
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::n_active_hexs (const unsigned int level) const {
   Assert (level < number_cache.n_hexes_level.size(),
@@ -3411,8 +3173,6 @@ unsigned int Triangulation<dim>::n_active_hexs (const unsigned int level) const
 };
 
 
-
-
 template <int dim>
 unsigned int Triangulation<dim>::n_levels () const {
   if (levels.size() == 0)
@@ -3438,7 +3198,6 @@ unsigned int Triangulation<dim>::n_levels () const {
 };
 
 
-
 template <int dim>
 unsigned int
 Triangulation<dim>::n_vertices () const 
@@ -3447,7 +3206,6 @@ Triangulation<dim>::n_vertices () const
 };
 
 
-
 template <int dim>
 unsigned int
 Triangulation<dim>::n_used_vertices () const 
@@ -3457,7 +3215,6 @@ Triangulation<dim>::n_used_vertices () const
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -3468,7 +3225,6 @@ unsigned int Triangulation<1>::max_adjacent_cells () const {
 #endif
 
 
-
 template <int dim>
 unsigned int Triangulation<dim>::max_adjacent_cells () const {
   cell_iterator cell = begin(0),
@@ -3497,9 +3253,6 @@ unsigned int Triangulation<dim>::max_adjacent_cells () const {
 };
 
 
-
-
-
 template <int dim>
 template <typename number>
 void Triangulation<dim>::refine (const Vector<number> &criteria,
@@ -3525,7 +3278,6 @@ void Triangulation<dim>::refine (const Vector<number> &criteria,
 };
 
 
-
 template <int dim>
 template <typename number>
 void Triangulation<dim>::coarsen (const Vector<number> &criteria,
@@ -3543,7 +3295,6 @@ void Triangulation<dim>::coarsen (const Vector<number> &criteria,
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -3582,7 +3333,6 @@ Triangulation<dim>::refine_and_coarsen_fixed_number (const Vector<number> &crite
 };
 
 
-
 static
 inline
 double sqr(double a) {
@@ -3590,7 +3340,6 @@ double sqr(double a) {
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -3677,9 +3426,6 @@ Triangulation<dim>::refine_and_coarsen_fixed_fraction (const Vector<number> &cri
 };
 
 
-
-
-
 template <int dim>
 void Triangulation<dim>::execute_coarsening_and_refinement () {
   prepare_coarsening_and_refinement ();
@@ -3689,8 +3435,6 @@ void Triangulation<dim>::execute_coarsening_and_refinement () {
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -3714,11 +3458,9 @@ void Triangulation<1>::execute_refinement () {
              break;
            };
     };
-  
 
 
-
-                                  // check how much space is needed
+// check how much space is needed
                                   // on every level
                                   // we need not check the highest
                                   // level since either
@@ -3779,7 +3521,7 @@ void Triangulation<1>::execute_refinement () {
     };
 
 
-                                  // Do REFINEMENT
+// Do REFINEMENT
                                   // on every level; exclude highest level as
                                   // above
 
@@ -3904,7 +3646,7 @@ void Triangulation<1>::execute_refinement () {
     };
 
 
-                                  // re-compute number of lines
+// re-compute number of lines
   update_number_cache ();
   
 #ifdef DEBUG
@@ -3927,7 +3669,6 @@ void Triangulation<1>::execute_refinement () {
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -3953,8 +3694,7 @@ void Triangulation<2>::execute_refinement () {
     };
 
 
-
-                                  // check how much space is needed
+// check how much space is needed
                                   // on every level
                                   // we need not check the highest
                                   // level since either
@@ -4059,9 +3799,9 @@ void Triangulation<2>::execute_refinement () {
        = count_if (levels[level+1]->quads.used.begin(),
                levels[level+1]->quads.used.end(),
                bind2nd (equal_to<bool>(), true));
-      
-      
-                                      // reserve space for the used_cells
+
+
+// reserve space for the used_cells
                                       // cells already existing on the next
                                       // higher level as well as for the
                                       // 4*flagged_cells that will be created
@@ -4095,7 +3835,7 @@ void Triangulation<2>::execute_refinement () {
     };
 
 
-                                  // Do REFINEMENT
+// Do REFINEMENT
                                   // on every level; exclude highest level as
                                   // above
 
@@ -4438,8 +4178,8 @@ void Triangulation<2>::execute_refinement () {
            new_lines[10]->set_boundary_indicator (255);
            new_lines[11]->set_boundary_indicator (255);
 
-           
-                                            // finally add the four new cells!
+
+// finally add the four new cells!
            
                                             // search for next unused cell
                                             // the four children have to be put
@@ -4455,10 +4195,9 @@ void Triangulation<2>::execute_refinement () {
                subcells[i] = next_unused_cell;
                ++next_unused_cell;
              };
-           
-           
-           
-           cell->set_children (subcells[0]->index());
+
+
+cell->set_children (subcells[0]->index());
            
            subcells[0]->set (Quad(new_lines[0]->index(),  new_lines[8]->index(),
                                   new_lines[10]->index(), new_lines[7]->index()));
@@ -4473,14 +4212,14 @@ void Triangulation<2>::execute_refinement () {
            subcells[1]->clear_user_pointer ();
 
 
-           subcells[2]->set (Quad(new_lines[11]->index(),  new_lines[3]->index(),
+subcells[2]->set (Quad(new_lines[11]->index(),  new_lines[3]->index(),
                                   new_lines[4]->index(), new_lines[9]->index()));
            subcells[2]->set_used_flag();
            subcells[2]->clear_children();
            subcells[2]->clear_user_pointer ();
-           
 
-           subcells[3]->set (Quad(new_lines[10]->index(),  new_lines[9]->index(),
+
+subcells[3]->set (Quad(new_lines[10]->index(),  new_lines[9]->index(),
                                   new_lines[5]->index(), new_lines[6]->index()));
            subcells[3]->set_used_flag();
            subcells[3]->clear_children();
@@ -4552,7 +4291,6 @@ void Triangulation<2>::execute_refinement () {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -4578,7 +4316,7 @@ void Triangulation<3>::execute_refinement () {
     };
 
 
-                                  // first clear user flags for
+// first clear user flags for
                                   // quads and lines; we're gonna
                                   // use them to flag which lines
                                   // and quads need refinement
@@ -4586,10 +4324,9 @@ void Triangulation<3>::execute_refinement () {
     line->clear_user_flag();
   for (quad_iterator quad=begin_quad(); quad!=end_quad(); ++quad)
     quad->clear_user_flag();
-  
 
 
-                                  // check how much space is needed
+// check how much space is needed
                                   // on every level
                                   // we need not check the highest
                                   // level since either
@@ -4666,17 +4403,17 @@ void Triangulation<3>::execute_refinement () {
            needed_lines += 2;
            needed_vertices += 1;
          };
-      
-      
-                                      // count number of used cells on
+
+
+// count number of used cells on
                                       // the next higher level
       const unsigned int used_cells
        = count_if (levels[level+1]->quads.used.begin(),
                levels[level+1]->quads.used.end(),
                bind2nd (equal_to<bool>(), true));
-      
-      
-                                      // reserve space for the used_cells
+
+
+// reserve space for the used_cells
                                       // cells already existing on the next
                                       // higher level as well as for the
                                       // 8*flagged_cells that will be created
@@ -4714,7 +4451,7 @@ void Triangulation<3>::execute_refinement () {
     };
 
 
-                                  ///////////////////////////////////////////
+///////////////////////////////////////////
                                   // Before we start with the actual
                                   // refinement, we do some sanity checks if
                                   // in debug mode. especially, we try to
@@ -4829,7 +4566,7 @@ void Triangulation<3>::execute_refinement () {
     };
 
 
-                                  ///////////////////////////////////////
+///////////////////////////////////////
                                   // now refine marked quads
                                   ///////////////////////////////////////
   for (unsigned int level=0; level!=levels.size()-1; ++level)
@@ -4918,8 +4655,7 @@ void Triangulation<3>::execute_refinement () {
              };
 
 
-
-                                            // now for the quads. again, first
+// now for the quads. again, first
                                             // collect some data about the
                                             // indices of the lines, with
                                             // the following numbering:
@@ -5071,9 +4807,9 @@ void Triangulation<3>::execute_refinement () {
 
                                             // compute average
            vertices[next_unused_vertex] /= 26;
-           
-         
-                                            // now that we created the right
+
+
+// now that we created the right
                                             // point, make up the six
                                             // lines interior to the quad
                                             // (++ takes care of the end of
@@ -5136,8 +4872,7 @@ void Triangulation<3>::execute_refinement () {
              };
 
 
-
-                                            // now for the quads. again, first
+// now for the quads. again, first
                                             // collect some data about the
                                             // indices of the lines, with
                                             // the following numbering:
@@ -5352,7 +5087,7 @@ void Triangulation<3>::execute_refinement () {
              };  
 
 
-                                            /////////////////////////////////
+/////////////////////////////////
                                             // create the eight new hexes
                                             //
                                             // again first collect some data.
@@ -5450,9 +5185,9 @@ void Triangulation<3>::execute_refinement () {
                    hex->face(5)->child_index(2),
                    hex->face(5)->child_index(3)
              };
-           
-           
-                                            // find some space for the eight
+
+
+// find some space for the eight
                                             // newly to be created hexes.
                                             // note that there should
                                             // always be eight consecutive
@@ -5524,9 +5259,9 @@ void Triangulation<3>::execute_refinement () {
                                          quad_indices[10],
                                          quad_indices[31],
                                          quad_indices[34]));
-           
-           
-           for (unsigned int i=0; i<8; ++i)
+
+
+for (unsigned int i=0; i<8; ++i)
              {
                new_hexes[i]->set_used_flag();
                new_hexes[i]->clear_user_flag();
@@ -5537,7 +5272,7 @@ void Triangulation<3>::execute_refinement () {
              };
 
 
-                                            /////////////////////////////////
+/////////////////////////////////
                                             // now the only thing still to be
                                             // done is setting neighborship
                                             // information.
@@ -5687,7 +5422,7 @@ void Triangulation<3>::execute_refinement () {
            new_hexes[7]->set_neighbor (5, neighbor_cells[5][2]);
 
 
-                                            // now we need to set the neighbors
+// now we need to set the neighbors
                                             // neighborship information; this
                                             // is only necessary if the
                                             // neighboring cell is refined,
@@ -5741,9 +5476,8 @@ void Triangulation<3>::execute_refinement () {
                                           new_hexes[child_on_face_and_subface[nb][subface]]);
                  };
 
-                   
-           
-                                            // note that the refinement
+
+// note that the refinement
                                             // flag was already cleared at
                                             // the beginning of this loop
          };
@@ -5781,12 +5515,9 @@ void Triangulation<3>::execute_refinement () {
 };
 
 
-
 #endif
 
 
-
-
 template <int dim>
 void Triangulation<dim>::execute_coarsening () {
                                   // loop over all cells. Flag all cells of
@@ -5821,9 +5552,9 @@ void Triangulation<dim>::execute_coarsening () {
              cell->child(child)->clear_coarsen_flag();
            };
        };
-  
 
-                                  // now do the actual coarsening step. Since
+
+// now do the actual coarsening step. Since
                                   // the loop goes over used cells only we need
                                   // not worry about deleting some cells since
                                   // the ++operator will then just hop over
@@ -5854,15 +5585,11 @@ void Triangulation<dim>::execute_coarsening () {
 };
 
 
-
-
-
 template <int dim>
 void Triangulation<dim>::prepare_refinement_dim_dependent () 
 {};
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -5895,7 +5622,7 @@ void Triangulation<3>::prepare_refinement_dim_dependent ()
              cell->line(line)->set_user_flag();
 
 
-                                      // now check whether there are cells with
+// now check whether there are cells with
                                       // lines that are more than once refined
                                       // or that will be more than once
                                       // refined. The first thing should never
@@ -5991,7 +5718,6 @@ void Triangulation<3>::prepare_refinement_dim_dependent ()
 #endif
 
 
-
 template <int dim>
 void Triangulation<dim>::fix_coarsen_flags () {
                                   // loop over all cells. Flag all cells of
@@ -6103,8 +5829,6 @@ void Triangulation<dim>::fix_coarsen_flags () {
            };
       };
 };
-  
-
 
 
 template <int dim>
@@ -6118,7 +5842,7 @@ bool Triangulation<dim>::prepare_coarsening_and_refinement () {
   save_refine_flags (flags_before[1]);
 
 
-                                  // do nothing in 1d, except setting the
+// do nothing in 1d, except setting the
                                   // coarsening flags correctly
   if (dim == 1)
     {
@@ -6309,9 +6033,9 @@ bool Triangulation<dim>::prepare_coarsening_and_refinement () {
                                      ==GeometryInfo<dim>::children_per_cell)
                                    not_active_neighbor_will_be_coarsened=true;
                                }
-                             
-                                   
-                             if ((neighbor->active() &&
+
+
+if ((neighbor->active() &&
                                   neighbor->refine_flag_set()) ||
                                  !not_active_neighbor_will_be_coarsened)
                                ++count;
@@ -6331,9 +6055,9 @@ bool Triangulation<dim>::prepare_coarsening_and_refinement () {
                }  // if (!cell->active())
            }  // for (all cells)
        } // if (smooth_grid & ...)
-      
 
-                                      //////////////////////////////////////
+
+//////////////////////////////////////
                                       // STEP 1:
                                       //    eliminate refined islands in the
                                       //    interior and at the boundary. since
@@ -6639,7 +6363,6 @@ bool Triangulation<dim>::prepare_coarsening_and_refinement () {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -6709,8 +6432,8 @@ void Triangulation<1>::delete_children (cell_iterator &cell) {
          };
       };
 
-       
-                                  // delete the vertex which will not be
+
+// delete the vertex which will not be
                                   // needed anymore. This vertex is the
                                   // second of the second line of the
                                   // first child
@@ -6726,9 +6449,9 @@ void Triangulation<1>::delete_children (cell_iterator &cell) {
       cell->child(child)->clear_user_flag();
       cell->child(child)->clear_used_flag();
     };
-  
-  
-                                  // delete pointer to children
+
+
+// delete pointer to children
   cell->set_children (-1);
   cell->clear_user_flag();
 };
@@ -6855,9 +6578,9 @@ void Triangulation<2>::delete_children (cell_iterator &cell) {
       cell->child(child)->clear_user_flag();
       cell->child(child)->clear_used_flag();
     };
-  
-  
-                                  // delete pointer to children
+
+
+// delete pointer to children
   cell->set_children (-1);
   cell->clear_user_flag();
 };
@@ -6865,7 +6588,6 @@ void Triangulation<2>::delete_children (cell_iterator &cell) {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 
@@ -7036,9 +6758,9 @@ void Triangulation<3>::delete_children (cell_iterator &cell) {
       cell->child(child)->clear_user_flag();
       cell->child(child)->clear_used_flag();
     };
-  
-  
-                                  // delete pointer to children
+
+
+// delete pointer to children
   cell->clear_children ();
   cell->clear_user_flag();
 
@@ -7170,8 +6892,8 @@ void Triangulation<3>::delete_children (cell_iterator &cell) {
        };
     };
 
-  
-                                  // now, if the lines are not marked as
+
+// now, if the lines are not marked as
                                   // needed, we may delete their children
                                   // and the midpoint
   map<line_iterator,bool>::iterator line_and_flag;
@@ -7197,7 +6919,6 @@ void Triangulation<3>::delete_children (cell_iterator &cell) {
 #endif
 
 
-
 template <int dim>
 void Triangulation<dim>::write_bool_vector (const unsigned int  magic_number1,
                                            const vector<bool> &v,
@@ -7229,7 +6950,6 @@ void Triangulation<dim>::write_bool_vector (const unsigned int  magic_number1,
 };
 
 
-
 template <int dim>
 void Triangulation<dim>::read_bool_vector (const unsigned int  magic_number1,
                                           vector<bool>       &v,
@@ -7265,8 +6985,6 @@ void Triangulation<dim>::read_bool_vector (const unsigned int  magic_number1,
 };
 
 
-
-
 template <int dim>
 void Triangulation<dim>::update_number_cache_lines () 
 {
@@ -7316,7 +7034,6 @@ void Triangulation<dim>::update_number_cache_lines ()
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -7475,9 +7192,6 @@ void Triangulation<dim>::update_number_cache ()
 };
 
 
-
-
-
 // explicit instantiations
 template class Triangulation<deal_II_dimension>;
 
index ae058d1562e3f7a112d81fbbb4d6c1485c75e8ed..5e013d01134c8b6e990b893eeeccc0cb48439c87 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  tria_accessor.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tria_accessor.cc  ---------------------------
 
 
 #include <grid/tria.h>
 #include <cmath>
 
 
-
-
-
-
 /*------------------------ Functions: LineAccessor ---------------------------*/
 
 template <int dim>
@@ -25,7 +31,6 @@ void TriaObjectAccessor<1, dim>::set (const Line &line) const {
 };
 
 
-
 template <int dim>
 int TriaObjectAccessor<1, dim>::vertex_index (const unsigned int i) const {
   Assert (i<2, ExcIndexRange(i,0,2));
@@ -33,7 +38,6 @@ int TriaObjectAccessor<1, dim>::vertex_index (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 Point<dim> &
 TriaObjectAccessor<1, dim>::vertex (const unsigned int i) const {
@@ -41,13 +45,11 @@ TriaObjectAccessor<1, dim>::vertex (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::set_used_flag () const {
   Assert (state() == valid, ExcDereferenceInvalidObject());
   tria->levels[present_level]->lines.used[present_index] = true;
 };
-  
 
 
 template <int dim>
@@ -57,7 +59,6 @@ void TriaObjectAccessor<1, dim>::clear_used_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::recursively_set_user_flag () const {
   set_user_flag ();
@@ -68,7 +69,6 @@ void TriaObjectAccessor<1, dim>::recursively_set_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::recursively_clear_user_flag () const {
   clear_user_flag ();
@@ -79,7 +79,6 @@ void TriaObjectAccessor<1, dim>::recursively_clear_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::set_user_pointer (void *p) const {
   Assert (used(), ExcCellNotUsed());
@@ -87,7 +86,6 @@ void TriaObjectAccessor<1, dim>::set_user_pointer (void *p) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::clear_user_pointer () const {
   Assert (used(), ExcCellNotUsed());
@@ -95,13 +93,12 @@ void TriaObjectAccessor<1, dim>::clear_user_pointer () const {
 };
 
 
-
 template <int dim>
 void * TriaObjectAccessor<1, dim>::user_pointer () const {
   Assert (used(), ExcCellNotUsed());
   return tria->levels[present_level]->lines.user_pointers[present_index];
 };
-  
+
 
 template <int dim>
 void TriaObjectAccessor<1, dim>::set_children (const int index) const {
@@ -113,14 +110,12 @@ void TriaObjectAccessor<1, dim>::set_children (const int index) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::clear_children () const {
   set_children (-1);
 };
 
 
-
 template <int dim>
 unsigned char TriaObjectAccessor<1, dim>::boundary_indicator () const {
   Assert (dim>=2, ExcNotUsefulForThisDimension());
@@ -130,7 +125,6 @@ unsigned char TriaObjectAccessor<1, dim>::boundary_indicator () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<1, dim>::set_boundary_indicator (unsigned char boundary_ind) const {
   Assert (dim>=2, ExcNotUsefulForThisDimension());
@@ -140,7 +134,6 @@ void TriaObjectAccessor<1, dim>::set_boundary_indicator (unsigned char boundary_
 };
 
 
-
 template <int dim>
 bool TriaObjectAccessor<1, dim>::at_boundary () const {
                                   // error checking is done
@@ -149,35 +142,30 @@ bool TriaObjectAccessor<1, dim>::at_boundary () const {
 };
 
 
-
 template <int dim>
 double TriaObjectAccessor<1, dim>::diameter () const {
   return sqrt((vertex(1)-vertex(0)).square());
 };
 
 
-
 template <int dim>
 Point<dim> TriaObjectAccessor<1, dim>::center () const {
   return (vertex(1)+vertex(0))/2.;
 };
 
 
-
 template <int dim>
 Point<dim> TriaObjectAccessor<1, dim>::barycenter () const {
   return (vertex(1)+vertex(0))/2.;
 };
 
 
-
 template <int dim>
 double TriaObjectAccessor<1, dim>::measure () const {
   return sqrt((vertex(1)-vertex(0)).square());
 };
 
 
-
 template <int dim>
 unsigned int TriaObjectAccessor<1, dim>::number_of_children () const {
   if (!has_children())
@@ -192,8 +180,6 @@ unsigned int TriaObjectAccessor<1, dim>::number_of_children () const {
 };
 
 
-
-
 /*------------------------ Functions: QuadAccessor ---------------------------*/
 
 template <int dim>
@@ -202,7 +188,6 @@ void TriaObjectAccessor<2, dim>::set (const Quad &quad) const {
 };
 
 
-
 template <int dim>
 int TriaObjectAccessor<2, dim>::vertex_index (const unsigned int corner) const {
   Assert (corner<4, ExcIndexRange(corner,0,4));
@@ -212,7 +197,6 @@ int TriaObjectAccessor<2, dim>::vertex_index (const unsigned int corner) const {
 };
 
 
-
 template <int dim>
 Point<dim> &
 TriaObjectAccessor<2, dim>::vertex (const unsigned int i) const {
@@ -220,15 +204,12 @@ TriaObjectAccessor<2, dim>::vertex (const unsigned int i) const {
 };
 
 
-
-
 template <int dim>
 void
 TriaObjectAccessor<2, dim>::set_used_flag () const {
   Assert (state() == valid, ExcDereferenceInvalidObject());
   tria->levels[present_level]->quads.used[present_index] = true;
 };
-  
 
 
 template <int dim>
@@ -238,7 +219,6 @@ void TriaObjectAccessor<2, dim>::clear_used_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::recursively_set_user_flag () const {
   set_user_flag ();
@@ -249,7 +229,6 @@ void TriaObjectAccessor<2, dim>::recursively_set_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::recursively_clear_user_flag () const {
   clear_user_flag ();
@@ -260,7 +239,6 @@ void TriaObjectAccessor<2, dim>::recursively_clear_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::set_user_pointer (void *p) const {
   Assert (used(), ExcCellNotUsed());
@@ -268,7 +246,6 @@ void TriaObjectAccessor<2, dim>::set_user_pointer (void *p) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::clear_user_pointer () const {
   Assert (used(), ExcCellNotUsed());
@@ -276,7 +253,6 @@ void TriaObjectAccessor<2, dim>::clear_user_pointer () const {
 };
 
 
-
 template <int dim>
 void * TriaObjectAccessor<2, dim>::user_pointer () const {
   Assert (used(), ExcCellNotUsed());
@@ -284,7 +260,6 @@ void * TriaObjectAccessor<2, dim>::user_pointer () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::set_children (const int index) const {
   Assert (used(), ExcCellNotUsed());
@@ -295,14 +270,12 @@ void TriaObjectAccessor<2, dim>::set_children (const int index) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::clear_children () const {
   set_children (-1);
 };
 
 
-
 template <int dim>
 unsigned char TriaObjectAccessor<2, dim>::boundary_indicator () const {
   Assert (dim>=3, ExcNotUsefulForThisDimension());
@@ -312,7 +285,6 @@ unsigned char TriaObjectAccessor<2, dim>::boundary_indicator () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<2, dim>::set_boundary_indicator (unsigned char boundary_ind) const {
   Assert (dim>=3, ExcNotUsefulForThisDimension());
@@ -322,7 +294,6 @@ void TriaObjectAccessor<2, dim>::set_boundary_indicator (unsigned char boundary_
 };
 
 
-
 template <int dim>
 bool TriaObjectAccessor<2, dim>::at_boundary () const {
                                   // error checking is done
@@ -331,7 +302,6 @@ bool TriaObjectAccessor<2, dim>::at_boundary () const {
 };
 
 
-
 template <int dim>
 double TriaObjectAccessor<2, dim>::diameter () const {
   return sqrt(max((vertex(2)-vertex(0)).square(),
@@ -339,14 +309,12 @@ double TriaObjectAccessor<2, dim>::diameter () const {
 };
 
 
-
 template <int dim>
 Point<dim> TriaObjectAccessor<2, dim>::center () const {
   return (vertex(0)+vertex(1)+vertex(2)+vertex(3))/4.;
 };
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -424,8 +392,6 @@ Point<2> TriaObjectAccessor<2, 2>::barycenter () const {
 };
 
 
-
-
 template <>
 double TriaObjectAccessor<2, 2>::measure () const {
                                   // the evaluation of the formulae
@@ -475,7 +441,6 @@ double TriaObjectAccessor<2, 2>::measure () const {
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -532,8 +497,6 @@ Point<3> TriaObjectAccessor<2, 3>::barycenter () const {
 };
 
 
-
-
 template <>
 double TriaObjectAccessor<2, 3>::measure () const {
                                   // the evaluation of the formulae
@@ -564,9 +527,6 @@ unsigned int TriaObjectAccessor<2, dim>::number_of_children () const {
 };
 
 
-
-
-
 /*------------------------ Functions: TriaObjectAccessor ---------------------------*/
 
 template <int dim>
@@ -575,7 +535,6 @@ void TriaObjectAccessor<3, dim>::set (const Hexahedron &hex) const {
 };
 
 
-
 template <int dim>
 int TriaObjectAccessor<3, dim>::vertex_index (const unsigned int corner) const {
   Assert (corner<8, ExcIndexRange(corner,0,8));
@@ -590,7 +549,6 @@ int TriaObjectAccessor<3, dim>::vertex_index (const unsigned int corner) const {
 };
 
 
-
 template <int dim>
 Point<dim> &
 TriaObjectAccessor<3, dim>::vertex (const unsigned int i) const {
@@ -598,13 +556,11 @@ TriaObjectAccessor<3, dim>::vertex (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::set_used_flag () const {
   Assert (state() == valid, ExcDereferenceInvalidObject());
   tria->levels[present_level]->hexes.used[present_index] = true;
 };
-  
 
 
 template <int dim>
@@ -614,8 +570,6 @@ void TriaObjectAccessor<3, dim>::clear_used_flag () const {
 };
 
 
-
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::recursively_set_user_flag () const {
   set_user_flag ();
@@ -626,7 +580,6 @@ void TriaObjectAccessor<3, dim>::recursively_set_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::recursively_clear_user_flag () const {
   clear_user_flag ();
@@ -637,7 +590,6 @@ void TriaObjectAccessor<3, dim>::recursively_clear_user_flag () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::set_user_pointer (void *p) const {
   Assert (used(), ExcCellNotUsed());
@@ -645,7 +597,6 @@ void TriaObjectAccessor<3, dim>::set_user_pointer (void *p) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::clear_user_pointer () const {
   Assert (used(), ExcCellNotUsed());
@@ -653,7 +604,6 @@ void TriaObjectAccessor<3, dim>::clear_user_pointer () const {
 };
 
 
-
 template <int dim>
 void * TriaObjectAccessor<3, dim>::user_pointer () const {
   Assert (used(), ExcCellNotUsed());
@@ -661,7 +611,6 @@ void * TriaObjectAccessor<3, dim>::user_pointer () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::set_children (const int index) const {
   Assert (used(), ExcCellNotUsed());
@@ -672,14 +621,12 @@ void TriaObjectAccessor<3, dim>::set_children (const int index) const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::clear_children () const {
   set_children (-1);
 };
 
 
-
 template <int dim>
 unsigned char TriaObjectAccessor<3, dim>::boundary_indicator () const {
   Assert (dim<4, ExcNotUsefulForThisDimension());
@@ -689,7 +636,6 @@ unsigned char TriaObjectAccessor<3, dim>::boundary_indicator () const {
 };
 
 
-
 template <int dim>
 void TriaObjectAccessor<3, dim>::set_boundary_indicator (unsigned char boundary_ind) const {
   Assert (dim<4, ExcNotUsefulForThisDimension());
@@ -699,7 +645,6 @@ void TriaObjectAccessor<3, dim>::set_boundary_indicator (unsigned char boundary_
 };
 
 
-
 template <int dim>
 bool TriaObjectAccessor<3, dim>::at_boundary () const {
                                   // error checking is done
@@ -708,7 +653,6 @@ bool TriaObjectAccessor<3, dim>::at_boundary () const {
 };
 
 
-
 template <int dim>
 double TriaObjectAccessor<3, dim>::diameter () const {
   return sqrt(max( max((vertex(6)-vertex(0)).square(),
@@ -718,7 +662,6 @@ double TriaObjectAccessor<3, dim>::diameter () const {
 };
 
 
-
 template <int dim>
 Point<dim> TriaObjectAccessor<3, dim>::center () const {
   return (vertex(0)+vertex(1)+vertex(2)+vertex(3)+
@@ -726,7 +669,6 @@ Point<dim> TriaObjectAccessor<3, dim>::center () const {
 };
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1377,8 +1319,6 @@ x[7]*y[3]-z[5]*x[6]*y[4]-z[5]*x[4]*y[1]+z[5]*x[4]*y[6]+x[1]*y[6]*z[2]+x[2]*y[6]
 };
 
 
-
-
 template <>
 double TriaObjectAccessor<3, 3>::measure () const {
 /*
@@ -1472,9 +1412,6 @@ unsigned int TriaObjectAccessor<3, dim>::number_of_children () const {
 };
 
 
-
-
-
 /*------------------------ Functions: CellAccessor<1> -----------------------*/
 
 
@@ -1486,7 +1423,6 @@ bool CellAccessor<1>::at_boundary () const {
 };
 
 
-
 template <>
 unsigned char CellAccessor<1>::material_id () const {
   Assert (used(), ExcCellNotUsed());
@@ -1494,7 +1430,6 @@ unsigned char CellAccessor<1>::material_id () const {
 };
 
 
-
 template <>
 void CellAccessor<1>::set_material_id (const unsigned char mat_id) const {
   Assert (used(), ExcCellNotUsed());
@@ -1517,7 +1452,6 @@ bool CellAccessor<2>::at_boundary () const {
 };
 
 
-
 template <>
 unsigned char CellAccessor<2>::material_id () const {
   Assert (used(), ExcCellNotUsed());
@@ -1525,7 +1459,6 @@ unsigned char CellAccessor<2>::material_id () const {
 };
 
 
-
 template <>
 void CellAccessor<2>::set_material_id (const unsigned char mat_id) const {
   Assert (used(), ExcCellNotUsed());
@@ -1536,7 +1469,6 @@ void CellAccessor<2>::set_material_id (const unsigned char mat_id) const {
 #endif
 
 
-
 /*------------------------ Functions: CellAccessor<3> -----------------------*/
 
 
@@ -1550,7 +1482,6 @@ bool CellAccessor<3>::at_boundary () const {
 };
 
 
-
 template <>
 unsigned char CellAccessor<3>::material_id () const {
   Assert (used(), ExcCellNotUsed());
@@ -1558,7 +1489,6 @@ unsigned char CellAccessor<3>::material_id () const {
 };
 
 
-
 template <>
 void CellAccessor<3>::set_material_id (const unsigned char mat_id) const {
   Assert (used(), ExcCellNotUsed());
@@ -1598,7 +1528,6 @@ void CellAccessor<dim>::set_neighbor (const unsigned int i,
 };
 
 
-
 template <int dim>
 unsigned int CellAccessor<dim>::neighbor_of_neighbor (const unsigned int neighbor) const
 {
@@ -1650,7 +1579,6 @@ unsigned int CellAccessor<dim>::neighbor_of_neighbor (const unsigned int neighbo
 };
 
 
-
 template <int dim>
 bool CellAccessor<dim>::at_boundary (const unsigned int i) const {
   Assert (used(), ExcCellNotUsed());
@@ -1661,9 +1589,6 @@ bool CellAccessor<dim>::at_boundary (const unsigned int i) const {
 };
 
 
-
-
-
 // explicit instantiations
 template class TriaAccessor<deal_II_dimension>;
 template class TriaObjectAccessor<1, deal_II_dimension>;
@@ -1690,7 +1615,3 @@ template class TriaActiveIterator<deal_II_dimension,TriaObjectAccessor<3, deal_I
 #endif
 
 
-
-
-
-
index 81280b632cfcbac658f0f197aa82b8f148dfd66c..23e3a7142a56f286093705e87eac958796909f4c 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  tria_boundary.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tria_boundary.cc  ---------------------------
 
 
 #include <grid/tria_boundary.h>
 #include <cmath>
 
 
-
 template <int dim>
 Boundary<dim>::~Boundary ()
 {};
 
 
-
-
 template <int dim>
 Point<dim>
 Boundary<dim>::get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &) const 
@@ -26,7 +33,6 @@ Boundary<dim>::get_new_point_on_quad (const typename Triangulation<dim>::quad_it
 };
 
 
-
 template <int dim>
 Point<dim>
 StraightBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const 
@@ -35,7 +41,6 @@ StraightBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>:
 };
 
 
-
 #if deal_II_dimension < 3
 
 template <int dim>
@@ -65,8 +70,6 @@ StraightBoundary<dim>::get_new_point_on_quad (const typename Triangulation<dim>:
 #endif
 
 
-
-
 // explicit instantiations
 template class Boundary<deal_II_dimension>;
 template class StraightBoundary<deal_II_dimension>;
index bf9d9eb8c1b020abcbc9c4eaa413c91aed807fef..945d4c6fab2e7264fbe68a0a16334b5b2d1b84d0 100644 (file)
@@ -1,5 +1,16 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  tria_boundary_lib.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tria_boundary_lib.cc  ---------------------------
+
 
 #include <grid/tria_boundary_lib.h>
 #include <grid/tria.h>
@@ -8,8 +19,6 @@
 #include <cmath>
 
 
-
-
 template <int dim>
 HyperBallBoundary<dim>::HyperBallBoundary (const Point<dim> p,
                                           const double     radius) :
@@ -17,7 +26,6 @@ HyperBallBoundary<dim>::HyperBallBoundary (const Point<dim> p,
 {};
 
 
-
 template <int dim>
 Point<dim>
 HyperBallBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const
@@ -33,7 +41,6 @@ HyperBallBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -48,7 +55,6 @@ get_new_point_on_quad (const Triangulation<1>::quad_iterator &) const
 #endif
 
 
-
 template <int dim>
 Point<dim>
 HyperBallBoundary<dim>::
@@ -65,7 +71,6 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
 };
 
 
-
 template <int dim>
 Point<dim>
 HyperBallBoundary<dim>::get_center () const 
@@ -74,7 +79,6 @@ HyperBallBoundary<dim>::get_center () const
 };
 
 
-
 template <int dim>
 double
 HyperBallBoundary<dim>::get_radius () const 
@@ -83,8 +87,6 @@ HyperBallBoundary<dim>::get_radius () const
 };
 
 
-
-
 template <int dim>
 HalfHyperBallBoundary<dim>::HalfHyperBallBoundary (const Point<dim> center,
                                                   const double     radius) :
@@ -92,7 +94,6 @@ HalfHyperBallBoundary<dim>::HalfHyperBallBoundary (const Point<dim> center,
 {};
 
 
-
 template <int dim>
 Point<dim>
 HalfHyperBallBoundary<dim>::
@@ -106,8 +107,6 @@ get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) c
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -135,7 +134,6 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
 };
 
 
-
 template <int dim>
 HyperShellBoundary<dim>::HyperShellBoundary (const Point<dim> &center) :
                center (center) 
@@ -163,7 +161,6 @@ get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) c
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -178,7 +175,6 @@ get_new_point_on_quad (const Triangulation<1>::quad_iterator &) const
 #endif
 
 
-
 template <int dim>
 Point<dim>
 HyperShellBoundary<dim>::
@@ -200,9 +196,6 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
 };
 
 
-
-
-
 // explicit instantiations
 template class HyperBallBoundary<deal_II_dimension>;
 template class HalfHyperBallBoundary<deal_II_dimension>;
index 06f3843ee3e54032b4f06d7d02a45834555ee108..74d47cdd3b7a63e7cecf76c3962a87a7e3c86a91 100644 (file)
@@ -1,4 +1,16 @@
-// $Id$
+//----------------------------  mg_base.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mg_base.cc  ---------------------------
+
 
 #include <multigrid/mg_base.h>
 #include <multigrid/mg_smoother.h>
@@ -6,7 +18,6 @@
 #include <cmath>
 
 
-
 //TODO: this function is only for debugging purposes and should be removed sometimes
 template<class VECTOR>
 static
@@ -27,7 +38,6 @@ void print_vector(ostream& s, const VECTOR& v)
 }
 
 
-
 //////////////////////////////////////////////////////////////////////
 
 
@@ -35,7 +45,6 @@ MGBase::~MGBase ()
 {};
 
 
-
 MGBase::MGBase(const MGTransferBase &transfer,
               const unsigned        minlevel,
               const unsigned        maxlevel)
@@ -51,7 +60,6 @@ MGBase::MGBase(const MGTransferBase &transfer,
 };
 
 
-
 void
 MGBase::vcycle(const MGSmootherBase     &pre_smooth,
               const MGSmootherBase     &post_smooth,
@@ -61,7 +69,6 @@ MGBase::vcycle(const MGSmootherBase     &pre_smooth,
 };
 
 
-
 void
 MGBase::level_mgstep(const unsigned int        level,
                     const MGSmootherBase     &pre_smooth,
@@ -113,13 +120,9 @@ MGCoarseGridSolver::~MGCoarseGridSolver()
 {};
 
 
-
 //////////////////////////////////////////////////////////////////////
 
 MGTransferBase::~MGTransferBase()
 {};
 
 
-
-
-
index c5ba004f22cf22e4a746ea114ce83474e9e418c8..c81fcd9fefa84f87342a8bdca17fd5ec3dc6de6d 100644 (file)
@@ -1,6 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-
+//----------------------------  mg_dof_accessor.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mg_dof_accessor.cc  ---------------------------
 
 
 #include <dofs/dof_levels.h>
 #include <lac/sparse_matrix.h>
 
 
-
-
-
-
 /* ------------------------ MGDoFLineAccessor --------------------------- */
 
 template <int dim>
@@ -31,7 +36,6 @@ MGDoFObjectAccessor<1, dim>::MGDoFObjectAccessor (Triangulation<dim> *tria,
 {};
 
 
-
 template <int dim>
 unsigned int MGDoFObjectAccessor<1, dim>::mg_dof_index (const unsigned int i) const
 {
@@ -48,9 +52,6 @@ unsigned int MGDoFObjectAccessor<1, dim>::mg_dof_index (const unsigned int i) co
 };
 
 
-
-
-
 template <int dim>
 void MGDoFObjectAccessor<1, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
@@ -68,8 +69,6 @@ void MGDoFObjectAccessor<1, dim>::set_mg_dof_index (const unsigned int i,
 };
 
 
-
-
 template <int dim>
 unsigned int MGDoFObjectAccessor<1, dim>::mg_vertex_dof_index (const unsigned int vertex,
                                                               const unsigned int i) const
@@ -86,7 +85,6 @@ unsigned int MGDoFObjectAccessor<1, dim>::mg_vertex_dof_index (const unsigned in
 };
 
 
-  
 template <int dim>
 void MGDoFObjectAccessor<1, dim>::set_mg_vertex_dof_index (const unsigned int vertex,
                                                           const unsigned int i,
@@ -104,7 +102,6 @@ void MGDoFObjectAccessor<1, dim>::set_mg_vertex_dof_index (const unsigned int ve
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<1, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indices) const
@@ -130,7 +127,6 @@ MGDoFObjectAccessor<1, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indic
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -159,7 +155,6 @@ MGDoFObjectAccessor<1,dim>::get_mg_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<1, dim> >
 MGDoFObjectAccessor<1, dim>::child (const unsigned int i) const
@@ -177,7 +172,6 @@ MGDoFObjectAccessor<1, dim>::child (const unsigned int i) const
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<1, dim>::copy_from (const MGDoFObjectAccessor<1, dim> &a)
@@ -187,8 +181,6 @@ MGDoFObjectAccessor<1, dim>::copy_from (const MGDoFObjectAccessor<1, dim> &a)
 };
 
 
-
-
 /* ------------------------ MGDoFQuadAccessor --------------------------- */
 
 template <int dim>
@@ -201,7 +193,6 @@ MGDoFObjectAccessor<2, dim>::MGDoFObjectAccessor (Triangulation<dim> *tria,
 {};
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFObjectAccessor<2, dim>::mg_dof_index (const unsigned int i) const
@@ -219,7 +210,6 @@ unsigned int MGDoFObjectAccessor<2, dim>::mg_dof_index (const unsigned int i) co
 };
 
 
-
 template <int dim>
 void MGDoFObjectAccessor<2, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
@@ -237,7 +227,6 @@ void MGDoFObjectAccessor<2, dim>::set_mg_dof_index (const unsigned int i,
 };
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFObjectAccessor<2, dim>::mg_vertex_dof_index (const unsigned int vertex,
@@ -255,7 +244,6 @@ unsigned int MGDoFObjectAccessor<2, dim>::mg_vertex_dof_index (const unsigned in
 };
 
 
-  
 template <int dim>
 void MGDoFObjectAccessor<2, dim>::set_mg_vertex_dof_index (const unsigned int vertex,
                                                           const unsigned int i,
@@ -273,7 +261,6 @@ void MGDoFObjectAccessor<2, dim>::set_mg_vertex_dof_index (const unsigned int ve
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<2, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indices) const
@@ -304,7 +291,6 @@ MGDoFObjectAccessor<2, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indic
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -337,7 +323,6 @@ MGDoFObjectAccessor<2,dim>::get_mg_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<1, dim> >
 MGDoFObjectAccessor<2, dim>::line (const unsigned int i) const
@@ -354,7 +339,6 @@ MGDoFObjectAccessor<2, dim>::line (const unsigned int i) const
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<2, dim> >
 MGDoFObjectAccessor<2, dim>::child (const unsigned int i) const
@@ -372,7 +356,6 @@ MGDoFObjectAccessor<2, dim>::child (const unsigned int i) const
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<2, dim>::copy_from (const MGDoFObjectAccessor<2, dim> &a)
@@ -382,8 +365,6 @@ MGDoFObjectAccessor<2, dim>::copy_from (const MGDoFObjectAccessor<2, dim> &a)
 };
 
 
-
-
 /* ------------------------ MGDoFHexAccessor --------------------------- */
 
 template <int dim>
@@ -396,7 +377,6 @@ MGDoFObjectAccessor<3, dim>::MGDoFObjectAccessor (Triangulation<dim> *tria,
 {};
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFObjectAccessor<3, dim>::mg_dof_index (const unsigned int i) const
@@ -414,7 +394,6 @@ unsigned int MGDoFObjectAccessor<3, dim>::mg_dof_index (const unsigned int i) co
 };
 
 
-
 template <int dim>
 void MGDoFObjectAccessor<3, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
@@ -432,7 +411,6 @@ void MGDoFObjectAccessor<3, dim>::set_mg_dof_index (const unsigned int i,
 };
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFObjectAccessor<3, dim>::mg_vertex_dof_index (const unsigned int vertex,
@@ -450,7 +428,6 @@ unsigned int MGDoFObjectAccessor<3, dim>::mg_vertex_dof_index (const unsigned in
 };
 
 
-  
 template <int dim>
 void MGDoFObjectAccessor<3, dim>::set_mg_vertex_dof_index (const unsigned int vertex,
                                                           const unsigned int i,
@@ -468,7 +445,6 @@ void MGDoFObjectAccessor<3, dim>::set_mg_vertex_dof_index (const unsigned int ve
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<3, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indices) const
@@ -504,7 +480,6 @@ MGDoFObjectAccessor<3, dim>::get_mg_dof_indices (vector<unsigned int> &dof_indic
 };
 
 
-
 template <int dim>
 template <typename number>
 void
@@ -541,7 +516,6 @@ MGDoFObjectAccessor<3,dim>::get_mg_dof_values (const Vector<number> &values,
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<1, dim> >
 MGDoFObjectAccessor<3, dim>::line (const unsigned int i) const {
@@ -557,7 +531,6 @@ MGDoFObjectAccessor<3, dim>::line (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<2, dim> >
 MGDoFObjectAccessor<3, dim>::quad (const unsigned int i) const {
@@ -573,7 +546,6 @@ MGDoFObjectAccessor<3, dim>::quad (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFObjectAccessor<3, dim> >
 MGDoFObjectAccessor<3, dim>::child (const unsigned int i) const {
@@ -590,7 +562,6 @@ MGDoFObjectAccessor<3, dim>::child (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 void
 MGDoFObjectAccessor<3, dim>::copy_from (const MGDoFObjectAccessor<3, dim> &a) {
@@ -599,9 +570,6 @@ MGDoFObjectAccessor<3, dim>::copy_from (const MGDoFObjectAccessor<3, dim> &a) {
 };
 
 
-
-
-
 /*------------------------- Functions: MGDoFCellAccessor -----------------------*/
 
 template <int dim>
@@ -620,7 +588,6 @@ MGDoFCellAccessor<dim>::neighbor (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 TriaIterator<dim,MGDoFCellAccessor<dim> >
 MGDoFCellAccessor<dim>::child (const unsigned int i) const {
@@ -637,7 +604,6 @@ MGDoFCellAccessor<dim>::child (const unsigned int i) const {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -651,7 +617,6 @@ MGDoFCellAccessor<1>::face (const unsigned int) const
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -664,8 +629,6 @@ MGDoFCellAccessor<2>::face (const unsigned int i) const
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 template <>
@@ -678,9 +641,6 @@ MGDoFCellAccessor<3>::face (const unsigned int i) const
 #endif
 
 
-
-
-
 // explicit instantiations
 
 template
@@ -696,7 +656,6 @@ get_mg_dof_values (const Vector<float> &values,
                   Vector<float>       &dof_values) const;
 
 
-
 #if deal_II_dimension >= 2
 
 template
index 9d0df564e1e997d3ac88d6b108beb1afffd5c1ee..19fb077eb8a4182700286208ae8762a1a0deb96b 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  mg_dof_handler.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mg_dof_handler.cc  ---------------------------
 
 
 #include <dofs/dof_levels.h>
@@ -17,7 +27,6 @@
 #include <algorithm>
 
 
-
 /* ------------------------ MGVertexDoFs ----------------------------------- */
 
 template <int dim>
@@ -28,7 +37,6 @@ MGDoFHandler<dim>::MGVertexDoFs::MGVertexDoFs () :
 {};
 
 
-
 template <int dim>
 void MGDoFHandler<dim>::MGVertexDoFs::init (const unsigned int cl,
                                            const unsigned int fl,
@@ -48,14 +56,12 @@ void MGDoFHandler<dim>::MGVertexDoFs::init (const unsigned int cl,
 };
 
 
-
 template <int dim>
 MGDoFHandler<dim>::MGVertexDoFs::~MGVertexDoFs () {
   delete[] indices;
 };
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_coarsest_level () const {
@@ -63,7 +69,6 @@ unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_coarsest_level () const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_finest_level () const {
@@ -71,10 +76,6 @@ unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_finest_level () const {
 };
 
 
-
-
-
-
 /* ------------------------ MGDoFHandler ------------------------------------- */
 
 template <int dim>
@@ -83,15 +84,10 @@ MGDoFHandler<dim>::MGDoFHandler (Triangulation<dim> &tria) :
 {};
 
 
-
 template <int dim>
 MGDoFHandler<dim>::~MGDoFHandler () {};
 
 
-
-
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -101,7 +97,6 @@ MGDoFHandler<1>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::begin (const unsigned int level) const {
@@ -109,7 +104,6 @@ MGDoFHandler<1>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::begin_active (const unsigned int level) const {
@@ -117,7 +111,6 @@ MGDoFHandler<1>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::end () const {
@@ -125,8 +118,6 @@ MGDoFHandler<1>::end () const {
 };
 
 
-
-
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::last_raw () const {
@@ -134,7 +125,6 @@ MGDoFHandler<1>::last_raw () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::last_raw (const unsigned int level) const {
@@ -142,7 +132,6 @@ MGDoFHandler<1>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::last () const {
@@ -150,7 +139,6 @@ MGDoFHandler<1>::last () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::last (const unsigned int level) const {
@@ -158,7 +146,6 @@ MGDoFHandler<1>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::last_active () const {
@@ -166,7 +153,6 @@ MGDoFHandler<1>::last_active () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::last_active (const unsigned int level) const {
@@ -174,7 +160,6 @@ MGDoFHandler<1>::last_active (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::begin_raw_face (const unsigned int) const {
@@ -183,7 +168,6 @@ MGDoFHandler<1>::begin_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::begin_face (const unsigned int) const {
@@ -192,7 +176,6 @@ MGDoFHandler<1>::begin_face (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::begin_active_face (const unsigned int) const {
@@ -201,7 +184,6 @@ MGDoFHandler<1>::begin_active_face (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::end_face () const {
@@ -210,7 +192,6 @@ MGDoFHandler<1>::end_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::last_raw_face () const {
@@ -219,7 +200,6 @@ MGDoFHandler<1>::last_raw_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::last_raw_face (const unsigned int) const {
@@ -228,7 +208,6 @@ MGDoFHandler<1>::last_raw_face (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::last_face () const {
@@ -237,7 +216,6 @@ MGDoFHandler<1>::last_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::last_face (const unsigned int) const {
@@ -246,7 +224,6 @@ MGDoFHandler<1>::last_face (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::last_active_face () const {
@@ -255,7 +232,6 @@ MGDoFHandler<1>::last_active_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::last_active_face (const unsigned int) const {
@@ -264,8 +240,6 @@ MGDoFHandler<1>::last_active_face (const unsigned int) const {
 };
 
 
-
-
 template <>
 MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::begin_raw_quad (const unsigned int) const {
@@ -274,7 +248,6 @@ MGDoFHandler<1>::begin_raw_quad (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::quad_iterator
 MGDoFHandler<1>::begin_quad (const unsigned int) const {
@@ -283,7 +256,6 @@ MGDoFHandler<1>::begin_quad (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::begin_active_quad (const unsigned int) const {
@@ -292,7 +264,6 @@ MGDoFHandler<1>::begin_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::end_quad () const {
@@ -301,7 +272,6 @@ MGDoFHandler<1>::end_quad () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::last_raw_quad (const unsigned int) const {
@@ -318,7 +288,6 @@ MGDoFHandler<1>::last_quad (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::last_active_quad (const unsigned int) const {
@@ -327,7 +296,6 @@ MGDoFHandler<1>::last_active_quad (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::last_raw_quad () const {
@@ -336,7 +304,6 @@ MGDoFHandler<1>::last_raw_quad () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::quad_iterator
 MGDoFHandler<1>::last_quad () const {
@@ -345,7 +312,6 @@ MGDoFHandler<1>::last_quad () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::last_active_quad () const {
@@ -362,7 +328,6 @@ MGDoFHandler<1>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::hex_iterator
 MGDoFHandler<1>::begin_hex (const unsigned int) const {
@@ -371,7 +336,6 @@ MGDoFHandler<1>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::begin_active_hex (const unsigned int) const {
@@ -380,7 +344,6 @@ MGDoFHandler<1>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::end_hex () const {
@@ -389,7 +352,6 @@ MGDoFHandler<1>::end_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::last_raw_hex (const unsigned int) const {
@@ -406,7 +368,6 @@ MGDoFHandler<1>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::last_active_hex (const unsigned int) const {
@@ -415,7 +376,6 @@ MGDoFHandler<1>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::last_raw_hex () const {
@@ -424,7 +384,6 @@ MGDoFHandler<1>::last_raw_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::hex_iterator
 MGDoFHandler<1>::last_hex () const {
@@ -433,7 +392,6 @@ MGDoFHandler<1>::last_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::last_active_hex () const {
@@ -444,7 +402,6 @@ MGDoFHandler<1>::last_active_hex () const {
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -454,7 +411,6 @@ MGDoFHandler<2>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::begin (const unsigned int level) const {
@@ -462,7 +418,6 @@ MGDoFHandler<2>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::begin_active (const unsigned int level) const {
@@ -470,7 +425,6 @@ MGDoFHandler<2>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::end () const {
@@ -478,7 +432,6 @@ MGDoFHandler<2>::end () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::last_raw () const {
@@ -486,7 +439,6 @@ MGDoFHandler<2>::last_raw () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::last_raw (const unsigned int level) const {
@@ -494,7 +446,6 @@ MGDoFHandler<2>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::last () const {
@@ -502,7 +453,6 @@ MGDoFHandler<2>::last () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::last (const unsigned int level) const {
@@ -510,7 +460,6 @@ MGDoFHandler<2>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::last_active () const {
@@ -518,7 +467,6 @@ MGDoFHandler<2>::last_active () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::last_active (const unsigned int level) const {
@@ -533,7 +481,6 @@ MGDoFHandler<2>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::begin_face (const unsigned int level) const {
@@ -541,7 +488,6 @@ MGDoFHandler<2>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::begin_active_face (const unsigned int level) const {
@@ -549,7 +495,6 @@ MGDoFHandler<2>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::end_face () const {
@@ -557,7 +502,6 @@ MGDoFHandler<2>::end_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::last_raw_face () const {
@@ -565,7 +509,6 @@ MGDoFHandler<2>::last_raw_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::last_raw_face (const unsigned int level) const {
@@ -573,7 +516,6 @@ MGDoFHandler<2>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::last_face () const {
@@ -581,7 +523,6 @@ MGDoFHandler<2>::last_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::last_face (const unsigned int level) const {
@@ -589,7 +530,6 @@ MGDoFHandler<2>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::last_active_face () const {
@@ -597,7 +537,6 @@ MGDoFHandler<2>::last_active_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::last_active_face (const unsigned int level) const {
@@ -605,7 +544,6 @@ MGDoFHandler<2>::last_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::begin_raw_hex (const unsigned int) const {
@@ -614,7 +552,6 @@ MGDoFHandler<2>::begin_raw_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::hex_iterator
 MGDoFHandler<2>::begin_hex (const unsigned int) const {
@@ -623,7 +560,6 @@ MGDoFHandler<2>::begin_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::begin_active_hex (const unsigned int) const {
@@ -632,7 +568,6 @@ MGDoFHandler<2>::begin_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::end_hex () const {
@@ -641,7 +576,6 @@ MGDoFHandler<2>::end_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::last_raw_hex (const unsigned int) const {
@@ -658,7 +592,6 @@ MGDoFHandler<2>::last_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::last_active_hex (const unsigned int) const {
@@ -667,7 +600,6 @@ MGDoFHandler<2>::last_active_hex (const unsigned int) const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::last_raw_hex () const {
@@ -676,7 +608,6 @@ MGDoFHandler<2>::last_raw_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::hex_iterator
 MGDoFHandler<2>::last_hex () const {
@@ -685,7 +616,6 @@ MGDoFHandler<2>::last_hex () const {
 };
 
 
-
 template <>
 MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::last_active_hex () const {
@@ -694,12 +624,9 @@ MGDoFHandler<2>::last_active_hex () const {
 };
 
 
-
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 template <>
@@ -709,7 +636,6 @@ MGDoFHandler<3>::begin_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::begin (const unsigned int level) const {
@@ -717,7 +643,6 @@ MGDoFHandler<3>::begin (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::begin_active (const unsigned int level) const {
@@ -725,7 +650,6 @@ MGDoFHandler<3>::begin_active (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::end () const {
@@ -733,7 +657,6 @@ MGDoFHandler<3>::end () const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::last_raw () const {
@@ -741,7 +664,6 @@ MGDoFHandler<3>::last_raw () const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::last_raw (const unsigned int level) const {
@@ -749,7 +671,6 @@ MGDoFHandler<3>::last_raw (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::last () const {
@@ -757,7 +678,6 @@ MGDoFHandler<3>::last () const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::last (const unsigned int level) const {
@@ -765,7 +685,6 @@ MGDoFHandler<3>::last (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::last_active () const {
@@ -773,7 +692,6 @@ MGDoFHandler<3>::last_active () const {
 };
 
 
-
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::last_active (const unsigned int level) const {
@@ -788,7 +706,6 @@ MGDoFHandler<3>::begin_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::begin_face (const unsigned int level) const {
@@ -796,7 +713,6 @@ MGDoFHandler<3>::begin_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::begin_active_face (const unsigned int level) const {
@@ -804,7 +720,6 @@ MGDoFHandler<3>::begin_active_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::end_face () const {
@@ -812,7 +727,6 @@ MGDoFHandler<3>::end_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::last_raw_face () const {
@@ -820,7 +734,6 @@ MGDoFHandler<3>::last_raw_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::last_raw_face (const unsigned int level) const {
@@ -828,7 +741,6 @@ MGDoFHandler<3>::last_raw_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::last_face () const {
@@ -836,7 +748,6 @@ MGDoFHandler<3>::last_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::last_face (const unsigned int level) const {
@@ -844,7 +755,6 @@ MGDoFHandler<3>::last_face (const unsigned int level) const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::last_active_face () const {
@@ -852,7 +762,6 @@ MGDoFHandler<3>::last_active_face () const {
 };
 
 
-
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::last_active_face (const unsigned int level) const {
@@ -862,9 +771,6 @@ MGDoFHandler<3>::last_active_face (const unsigned int level) const {
 #endif
 
 
-
-
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::begin_raw_line (const unsigned int level) const {
@@ -875,7 +781,6 @@ MGDoFHandler<dim>::begin_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::line_iterator
 MGDoFHandler<dim>::begin_line (const unsigned int level) const {
@@ -886,7 +791,6 @@ MGDoFHandler<dim>::begin_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_line_iterator
 MGDoFHandler<dim>::begin_active_line (const unsigned int level) const {
@@ -897,7 +801,6 @@ MGDoFHandler<dim>::begin_active_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
@@ -908,7 +811,6 @@ MGDoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::quad_iterator
 MGDoFHandler<dim>::begin_quad (const unsigned int level) const {
@@ -919,7 +821,6 @@ MGDoFHandler<dim>::begin_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_quad_iterator
 MGDoFHandler<dim>::begin_active_quad (const unsigned int level) const {
@@ -930,7 +831,6 @@ MGDoFHandler<dim>::begin_active_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
@@ -941,7 +841,6 @@ MGDoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::hex_iterator
 MGDoFHandler<dim>::begin_hex (const unsigned int level) const {
@@ -952,7 +851,6 @@ MGDoFHandler<dim>::begin_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_hex_iterator
 MGDoFHandler<dim>::begin_active_hex (const unsigned int level) const {
@@ -963,7 +861,6 @@ MGDoFHandler<dim>::begin_active_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::end_line () const {
@@ -971,7 +868,6 @@ MGDoFHandler<dim>::end_line () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::end_quad () const {
@@ -979,7 +875,6 @@ MGDoFHandler<dim>::end_quad () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::end_hex () const {
@@ -987,7 +882,6 @@ MGDoFHandler<dim>::end_hex () const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::raw_cell_iterator
 MGDoFHandler<dim>::end_raw (const unsigned int level) const {
@@ -997,7 +891,6 @@ MGDoFHandler<dim>::end_raw (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::cell_iterator
 MGDoFHandler<dim>::end (const unsigned int level) const {
@@ -1007,7 +900,6 @@ MGDoFHandler<dim>::end (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::active_cell_iterator
 MGDoFHandler<dim>::end_active (const unsigned int level) const {
@@ -1017,7 +909,6 @@ MGDoFHandler<dim>::end_active (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::raw_face_iterator
 MGDoFHandler<dim>::end_raw_face (const unsigned int level) const {
@@ -1027,7 +918,6 @@ MGDoFHandler<dim>::end_raw_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::face_iterator
 MGDoFHandler<dim>::end_face (const unsigned int level) const {
@@ -1037,7 +927,6 @@ MGDoFHandler<dim>::end_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::active_face_iterator
 MGDoFHandler<dim>::end_active_face (const unsigned int level) const {
@@ -1047,7 +936,6 @@ MGDoFHandler<dim>::end_active_face (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::raw_line_iterator
 MGDoFHandler<dim>::end_raw_line (const unsigned int level) const {
@@ -1057,7 +945,6 @@ MGDoFHandler<dim>::end_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::line_iterator
 MGDoFHandler<dim>::end_line (const unsigned int level) const {
@@ -1067,7 +954,6 @@ MGDoFHandler<dim>::end_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::active_line_iterator
 MGDoFHandler<dim>::end_active_line (const unsigned int level) const {
@@ -1077,8 +963,6 @@ MGDoFHandler<dim>::end_active_line (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::raw_quad_iterator
 MGDoFHandler<dim>::end_raw_quad (const unsigned int level) const {
@@ -1088,7 +972,6 @@ MGDoFHandler<dim>::end_raw_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::quad_iterator
 MGDoFHandler<dim>::end_quad (const unsigned int level) const {
@@ -1098,8 +981,6 @@ MGDoFHandler<dim>::end_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::active_quad_iterator
 MGDoFHandler<dim>::end_active_quad (const unsigned int level) const {
@@ -1109,7 +990,6 @@ MGDoFHandler<dim>::end_active_quad (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::raw_hex_iterator
 MGDoFHandler<dim>::end_raw_hex (const unsigned int level) const {
@@ -1119,7 +999,6 @@ MGDoFHandler<dim>::end_raw_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::hex_iterator
 MGDoFHandler<dim>::end_hex (const unsigned int level) const {
@@ -1129,8 +1008,6 @@ MGDoFHandler<dim>::end_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFDimensionInfo<dim>::active_hex_iterator
 MGDoFHandler<dim>::end_active_hex (const unsigned int level) const {
@@ -1140,7 +1017,6 @@ MGDoFHandler<dim>::end_active_hex (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::last_raw_line (const unsigned int level) const {
@@ -1151,7 +1027,6 @@ MGDoFHandler<dim>::last_raw_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::line_iterator
 MGDoFHandler<dim>::last_line (const unsigned int level) const {
@@ -1162,7 +1037,6 @@ MGDoFHandler<dim>::last_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_line_iterator
 MGDoFHandler<dim>::last_active_line (const unsigned int level) const {
@@ -1173,7 +1047,6 @@ MGDoFHandler<dim>::last_active_line (const unsigned int level) const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::last_raw_quad (const unsigned int level) const {
@@ -1184,8 +1057,6 @@ MGDoFHandler<dim>::last_raw_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::quad_iterator
 MGDoFHandler<dim>::last_quad (const unsigned int level) const {
@@ -1196,8 +1067,6 @@ MGDoFHandler<dim>::last_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::active_quad_iterator
 MGDoFHandler<dim>::last_active_quad (const unsigned int level) const {
@@ -1208,8 +1077,6 @@ MGDoFHandler<dim>::last_active_quad (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::last_raw_hex (const unsigned int level) const {
@@ -1220,8 +1087,6 @@ MGDoFHandler<dim>::last_raw_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::hex_iterator
 MGDoFHandler<dim>::last_hex (const unsigned int level) const {
@@ -1232,8 +1097,6 @@ MGDoFHandler<dim>::last_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::active_hex_iterator
 MGDoFHandler<dim>::last_active_hex (const unsigned int level) const {
@@ -1244,8 +1107,6 @@ MGDoFHandler<dim>::last_active_hex (const unsigned int level) const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::last_raw_line () const {
@@ -1253,7 +1114,6 @@ MGDoFHandler<dim>::last_raw_line () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::last_raw_quad () const {
@@ -1261,7 +1121,6 @@ MGDoFHandler<dim>::last_raw_quad () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::last_raw_hex () const {
@@ -1269,7 +1128,6 @@ MGDoFHandler<dim>::last_raw_hex () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::line_iterator
 MGDoFHandler<dim>::last_line () const {
@@ -1277,7 +1135,6 @@ MGDoFHandler<dim>::last_line () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::quad_iterator
 MGDoFHandler<dim>::last_quad () const {
@@ -1285,7 +1142,6 @@ MGDoFHandler<dim>::last_quad () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::hex_iterator
 MGDoFHandler<dim>::last_hex () const {
@@ -1293,7 +1149,6 @@ MGDoFHandler<dim>::last_hex () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_line_iterator
 MGDoFHandler<dim>::last_active_line () const {
@@ -1301,8 +1156,6 @@ MGDoFHandler<dim>::last_active_line () const {
 };
 
 
-
-
 template <int dim>
 typename MGDoFHandler<dim>::active_quad_iterator
 MGDoFHandler<dim>::last_active_quad () const {
@@ -1310,7 +1163,6 @@ MGDoFHandler<dim>::last_active_quad () const {
 };
 
 
-
 template <int dim>
 typename MGDoFHandler<dim>::active_hex_iterator
 MGDoFHandler<dim>::last_active_hex () const {
@@ -1318,18 +1170,9 @@ MGDoFHandler<dim>::last_active_hex () const {
 };
 
 
-
-
-
-
 //------------------------------------------------------------------
 
 
-
-
-
-
-
 template <int dim>
 void MGDoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &fe,
                                         unsigned int offset)
@@ -1338,7 +1181,7 @@ void MGDoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &fe,
   DoFHandler<dim>::distribute_dofs (fe, offset);
 
 
-                                  // reserve space for the MG dof numbers
+// reserve space for the MG dof numbers
   reserve_space ();
   mg_used_dofs.resize (tria->n_levels(), 0);
 
@@ -1362,7 +1205,6 @@ void MGDoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &fe,
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1448,15 +1290,15 @@ MGDoFHandler<2>::distribute_dofs_on_cell (cell_iterator &cell,
          for (unsigned int d=0; d<selected_fe->dofs_per_line; ++d)
            line->set_mg_dof_index (d, next_free_dof++);            
       };
-  
 
-                                      // dofs of quad
+
+// dofs of quad
   if (selected_fe->dofs_per_quad > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_quad; ++d)
       cell->set_mg_dof_index (d, next_free_dof++);
 
-  
-                                  // note that this cell has been processed
+
+// note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1465,7 +1307,6 @@ MGDoFHandler<2>::distribute_dofs_on_cell (cell_iterator &cell,
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1511,15 +1352,15 @@ MGDoFHandler<3>::distribute_dofs_on_cell (cell_iterator &cell,
          for (unsigned int d=0; d<selected_fe->dofs_per_line; ++d)
            quad->set_mg_dof_index (d, next_free_dof++);            
       };
-  
 
-                                      // dofs of cell
+
+// dofs of cell
   if (selected_fe->dofs_per_hex > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_hex; ++d)
       cell->set_mg_dof_index (d, next_free_dof++);
 
-  
-                                  // note that this cell has been processed
+
+// note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1528,8 +1369,6 @@ MGDoFHandler<3>::distribute_dofs_on_cell (cell_iterator &cell,
 #endif
 
 
-
-
 template <int dim>
 unsigned int MGDoFHandler<dim>::n_dofs (const unsigned int level) const {
   Assert (level < mg_used_dofs.size(), ExcInvalidLevel(level));
@@ -1538,7 +1377,6 @@ unsigned int MGDoFHandler<dim>::n_dofs (const unsigned int level) const {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1574,8 +1412,6 @@ void MGDoFHandler<1>::renumber_dofs (const unsigned int level,
 #endif
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -1612,7 +1448,6 @@ void MGDoFHandler<2>::renumber_dofs (const unsigned int  level,
 #endif
 
 
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1656,8 +1491,6 @@ void MGDoFHandler<3>::renumber_dofs (const unsigned int  level,
 #endif
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -1742,7 +1575,6 @@ void MGDoFHandler<1>::reserve_space () {
 #endif
 
 
-
 #if deal_II_dimension == 2
 
 template <>
@@ -1767,9 +1599,9 @@ void MGDoFHandler<2>::reserve_space () {
                                   // this calls the destructor which
                                   // must free the space
   mg_vertex_dofs.clear ();
-  
-  
-                                  ////////////////////////////
+
+
+////////////////////////////
                                   // CONSTRUCTION
   
                                   // first allocate space for the
@@ -1786,8 +1618,8 @@ void MGDoFHandler<2>::reserve_space () {
                                                          DoFHandler<2>::invalid_dof_index);
     };
 
-  
-                                  // now allocate space for the
+
+// now allocate space for the
                                   // vertices. To this end, we need
                                   // to construct as many objects as
                                   // there are vertices and let them
@@ -1817,8 +1649,8 @@ void MGDoFHandler<2>::reserve_space () {
          max_level[vertex_index] = cell->level();
       };
 
-  
-                                  // now allocate the needed space
+
+// now allocate the needed space
   for (unsigned int vertex=0; vertex<tria->vertices.size(); ++vertex)
     {
       Assert (min_level[vertex] < tria->n_levels(),   ExcInternalError());
@@ -1833,8 +1665,6 @@ void MGDoFHandler<2>::reserve_space () {
 #endif
 
 
-
-
 #if deal_II_dimension == 3
 
 template <>
@@ -1859,9 +1689,9 @@ void MGDoFHandler<3>::reserve_space () {
                                   // this calls the destructor which
                                   // must free the space
   mg_vertex_dofs.clear ();
-  
-  
-                                  ////////////////////////////
+
+
+////////////////////////////
                                   // CONSTRUCTION
   
                                   // first allocate space for the
@@ -1881,8 +1711,8 @@ void MGDoFHandler<3>::reserve_space () {
                                                         DoFHandler<3>::invalid_dof_index);
     };
 
-  
-                                  // now allocate space for the
+
+// now allocate space for the
                                   // vertices. To this end, we need
                                   // to construct as many objects as
                                   // there are vertices and let them
@@ -1912,8 +1742,8 @@ void MGDoFHandler<3>::reserve_space () {
          max_level[vertex_index] = cell->level();
       };
 
-  
-                                  // now allocate the needed space
+
+// now allocate the needed space
   for (unsigned int vertex=0; vertex<tria->vertices.size(); ++vertex)
     {
       Assert (min_level[vertex] < tria->n_levels(),   ExcInternalError());
index 7cc6d0b60142186236e04d0263689a8abef2ab7c..220848df94c9795393fba15c33a2e831e9cb7206 100644 (file)
@@ -1,4 +1,15 @@
-/* $Id$ */
+//----------------------------  mg_dof_tools.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mg_dof_tools.cc  ---------------------------
 
 
 #include <lac/sparsity_pattern.h>
@@ -68,7 +79,8 @@ MGDoFTools::make_flux_sparsity_pattern (const MGDoFHandler<dim> &dof,
           face < GeometryInfo<dim>::faces_per_cell;
           ++face)
        {
-         if ( (! cell->at_boundary(face)) && (cell->neighbor_level(face) == level) )
+         if ( (! cell->at_boundary(face)) &&
+              (static_cast<unsigned int>(cell->neighbor_level(face)) == level) )
            {
              DoFHandler<dim>::cell_iterator neighbor = cell->neighbor(face);
              neighbor->get_dof_indices (dofs_on_other_cell);
index 243c93f2d5d5d5cf206c018e7424fb40978917cf..e8add60f5838f8becacc28cecdab2a3776bf2cbb 100644 (file)
@@ -1,4 +1,15 @@
-/* $Id$ */
+//----------------------------  mg_smoother.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mg_smoother.cc  ---------------------------
 
 
 #include <grid/tria.h>
@@ -14,7 +25,6 @@
 #include <algorithm>
 
 
-
 //////////////////////////////////////////////////////////////////////
 
 
@@ -32,8 +42,6 @@ MGSmootherIdentity::smooth (const unsigned int,
 {};
 
 
-
-
 #if deal_II_dimension == 1
 
 MGSmoother::MGSmoother (const MGDoFHandler<1> &/*mg_dof*/, unsigned int steps)
index afa6ad4a780300cdb48b786d88244befee01c20c..3dfefa448f3be6f433e80bc4a0b0a6dac8ad486a 100644 (file)
@@ -1,4 +1,15 @@
-// $Id$
+//----------------------------  multigrid.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  multigrid.cc  ---------------------------
 
 
 #include <grid/tria.h>
@@ -12,7 +23,6 @@
 #include <lac/vector.h>
 
 
-
 /* --------------------------------- MG ------------------------------------ */
 
 template <int dim>
@@ -34,7 +44,6 @@ Multigrid<dim>::Multigrid (const MGDoFHandler<dim>                       &mg_dof
 {};
 
 
-
 template <int dim>
 void
 Multigrid<dim>::level_vmult (const unsigned int    level,
@@ -47,19 +56,13 @@ Multigrid<dim>::level_vmult (const unsigned int    level,
 }
 
 
-
-
-
-
 /* ----------------------------- MGTransferPrebuilt ------------------------ */
 
 
-
 MGTransferPrebuilt::~MGTransferPrebuilt () 
 {};
 
 
-
 template <int dim>
 void MGTransferPrebuilt::build_matrices (const MGDoFHandler<dim> &mg_dof) 
 {
@@ -72,9 +75,9 @@ void MGTransferPrebuilt::build_matrices (const MGDoFHandler<dim> &mg_dof)
   prolongation_matrices.clear ();
   prolongation_sparsities.reserve (n_levels-1);
   prolongation_matrices.reserve (n_levels-1);
-  
 
-                                  // two fields which will store the
+
+// two fields which will store the
                                   // indices of the multigrid dofs
                                   // for a cell and one of its children
   vector<unsigned int> dof_indices_mother (dofs_per_cell);
@@ -136,7 +139,7 @@ void MGTransferPrebuilt::build_matrices (const MGDoFHandler<dim> &mg_dof)
       prolongation_matrices[level].reinit (prolongation_sparsities[level]);
 
 
-                                      // now actually build the matrices
+// now actually build the matrices
       for (MGDoFHandler<dim>::cell_iterator cell=mg_dof.begin(level);
           cell != mg_dof.end(level); ++cell)
        if (cell->has_children())
@@ -171,7 +174,6 @@ void MGTransferPrebuilt::build_matrices (const MGDoFHandler<dim> &mg_dof)
 };
 
 
-
 void MGTransferPrebuilt::prolongate (const unsigned int   to_level,
                                     Vector<double>       &dst,
                                     const Vector<double> &src) const 
@@ -183,7 +185,6 @@ void MGTransferPrebuilt::prolongate (const unsigned int   to_level,
 };
 
 
-
 void MGTransferPrebuilt::restrict_and_add (const unsigned int   from_level,
                                           Vector<double>       &dst,
                                           const Vector<double> &src) const 
@@ -195,7 +196,6 @@ void MGTransferPrebuilt::restrict_and_add (const unsigned int   from_level,
 };
 
 
-
 // explicit instatations
 template class Multigrid<deal_II_dimension>;
 template
@@ -213,4 +213,4 @@ void Multigrid<deal_II_dimension>::copy_from_mg (Vector<float>& src) const;
 template
 void Multigrid<deal_II_dimension>::copy_from_mg (Vector<double>& src) const;
 
-  
+
index d634123407735b78bacd0995050a9823de10234d..04da87f36ee244e030177d0b353a9e6b347522c2 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  assembler.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  assembler.cc  ---------------------------
 
 
 #include <numerics/assembler.h>
@@ -29,8 +39,6 @@ Assembler<dim>::AssemblerData::AssemblerData (const DoFHandler<dim>    &dof,
 {};
 
 
-
-
 template <int dim>
 Assembler<dim>::Assembler (Triangulation<dim>  *tria,
                           const int            level,
@@ -56,7 +64,6 @@ Assembler<dim>::Assembler (Triangulation<dim>  *tria,
 };
 
 
-
 template <int dim>
 void Assembler<dim>::assemble (const Equation<dim> &equation) {
                                   // re-init fe values for this cell
@@ -67,9 +74,9 @@ void Assembler<dim>::assemble (const Equation<dim> &equation) {
     cell_matrix.clear ();
   if (assemble_rhs)
     cell_vector.clear ();
-  
 
-                                  // fill cell matrix and vector if required
+
+// fill cell matrix and vector if required
   DoFHandler<dim>::cell_iterator this_cell (*this);
   if (assemble_matrix && assemble_rhs) 
     equation.assemble (cell_matrix, cell_vector, fe_values, this_cell);
@@ -83,7 +90,7 @@ void Assembler<dim>::assemble (const Equation<dim> &equation) {
        Assert (false, ExcNoAssemblingRequired());
 
 
-                                  // get indices of dofs
+// get indices of dofs
   vector<unsigned int> dofs (n_dofs);
   get_dof_indices (dofs);
 
@@ -105,9 +112,6 @@ void Assembler<dim>::assemble (const Equation<dim> &equation) {
       rhs_vector(dofs[j]) += cell_vector(j);
 };
 
-               
-
-
 
 // explicit instantiations
 template class Assembler<deal_II_dimension>;
index 98b0dfb0ea105ece69d11be80b00ada3bab63974..7a07c3711cc6e41de81994833f92423ad30e6c53 100644 (file)
@@ -1,5 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  base.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  base.cc  ---------------------------
 
 
 #include <numerics/assembler.h>
@@ -24,7 +34,6 @@
 #include <cmath>
 
 
-
 template <int dim>
 ProblemBase<dim>::ProblemBase () :
                tria(0),
@@ -34,7 +43,6 @@ ProblemBase<dim>::ProblemBase () :
 {};
 
 
-
 template <int dim>
 void ProblemBase<dim>::set_tria_and_dof (Triangulation<dim> *t,
                                         DoFHandler<dim>    *d)
@@ -53,7 +61,6 @@ void ProblemBase<dim>::set_tria_and_dof (Triangulation<dim> *t,
 };
 
 
-
 template <int dim>
 void ProblemBase<dim>::clear () {
   if (tria)        { delete tria;         tria        = 0; };
@@ -66,12 +73,10 @@ void ProblemBase<dim>::clear () {
 };
 
 
-
 template <int dim>
 ProblemBase<dim>::~ProblemBase () {};
 
 
-
 template <int dim>
 void ProblemBase<dim>::assemble (const Equation<dim>      &equation,
                                 const Quadrature<dim>    &quadrature,
@@ -139,8 +144,6 @@ void ProblemBase<dim>::assemble (const Equation<dim>      &equation,
 };
 
 
-
-
 template <int dim>
 void ProblemBase<dim>::solve ()
 {
@@ -162,8 +165,6 @@ void ProblemBase<dim>::solve ()
 };
 
 
-
-
 template <int dim>
 void ProblemBase<dim>::fill_data (DataOut<dim> &out) const {
   Assert ((tria!=0) && (dof_handler!=0), ExcNoTriaSelected());
@@ -175,17 +176,11 @@ void ProblemBase<dim>::fill_data (DataOut<dim> &out) const {
 };
 
 
-
 template <int dim>
 string ProblemBase<dim>::get_solution_name () const {
   return "solution";
 };
 
 
-
-
-  
-
-
 // explicit instantiations
 template class ProblemBase<deal_II_dimension>;
index 869efa5cf9af455d9a556d21709aa7623e4f14e0..1c070ed2e74dbe0415fd1633e04fb885ab1b3968 100644 (file)
@@ -1,6 +1,16 @@
-/* $Id$ */
-/* Copyright W. Bangerth, Guido Kanschat, Stefan Nauber  */
-/* University of Heidelberg, 1998, 1999                  */
+//----------------------------  data_io.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  data_io.cc  ---------------------------
+
 
 #include <numerics/data_io.h>
 #include <dofs/dof_handler.h>
 #include <cmath>
 
 
-
-
 template <int dim>
 DataOut_Old<dim>::DataEntry::DataEntry () :
                data(0), name(""), units("") {};
 
 
-
 template <int dim>
 DataOut_Old<dim>::DataEntry::DataEntry (const Vector<double> *data,
                                    const string name,
@@ -36,21 +43,17 @@ DataOut_Old<dim>::DataEntry::DataEntry (const Vector<double> *data,
                        data(data), name(name), units(units) {};
 
 
-
-
 template <int dim>
 DataOut_Old<dim>::DataOut_Old () :
                dofs(0) {};
 
 
-
 template <int dim>
 void DataOut_Old<dim>::attach_dof_handler (const DoFHandler<dim> &d) {
   dofs = &d;
 };
 
 
-
 template <int dim>
 void DataOut_Old<dim>::add_data_vector (const Vector<double> &vec,
                                    const string  &name,
@@ -79,7 +82,6 @@ void DataOut_Old<dim>::add_data_vector (const Vector<double> &vec,
 };
 
 
-
 template <int dim>
 void DataOut_Old<dim>::clear_data_vectors () {
   dof_data.erase (dof_data.begin(), dof_data.end());
@@ -87,7 +89,6 @@ void DataOut_Old<dim>::clear_data_vectors () {
 };
 
 
-
 template <int dim>
 void DataOut_Old<dim>::write_ucd (ostream &out) const {
   Assert (dofs != 0, ExcNoDoFHandlerSelected());
@@ -118,9 +119,9 @@ void DataOut_Old<dim>::write_ucd (ostream &out) const {
        if (is_vertex_dof[i] == true)
          ++n_vertex_dofs;
     };
-  
 
-                                  // write preamble
+
+// write preamble
   if (true)
     {
 /*      
@@ -304,7 +305,6 @@ void DataOut_Old<dim>::write_ucd (ostream &out) const {
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -315,7 +315,6 @@ unsigned int DataOut_Old<1>::n_boundary_faces () const {
 #endif
 
 
-
 template <int dim>
 unsigned int DataOut_Old<dim>::n_boundary_faces () const {
   typename DoFHandler<dim>::active_face_iterator face, endf;
@@ -331,8 +330,6 @@ unsigned int DataOut_Old<dim>::n_boundary_faces () const {
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -374,9 +371,6 @@ void DataOut_Old<dim>::write_ucd_faces (ostream &out,
   AssertThrow (out, ExcIO());
 };
 
-      
-
-
 
 template <int dim>
 void DataOut_Old<dim>::write_gnuplot (ostream &out, unsigned int accuracy) const
@@ -438,7 +432,7 @@ void DataOut_Old<dim>::write_gnuplot (ostream &out, unsigned int accuracy) const
     };
 
 
-  DoFHandler<dim>::active_cell_iterator cell;
+DoFHandler<dim>::active_cell_iterator cell;
   DoFHandler<dim>::active_cell_iterator endc = dofs->end();
 
   QTrapez<1>     q_trapez;
@@ -547,9 +541,9 @@ void DataOut_Old<dim>::write_gnuplot (ostream &out, unsigned int accuracy) const
                      }
                    out << endl;
                  };
-               
-               
-               break;
+
+
+break;
 
          default:
                Assert (false, ExcNotImplemented());
@@ -561,7 +555,6 @@ void DataOut_Old<dim>::write_gnuplot (ostream &out, unsigned int accuracy) const
 }
 
 
-
 template <int dim>
 void DataOut_Old<dim>::write_gnuplot_draft (ostream &out) const
 {
@@ -617,7 +610,7 @@ void DataOut_Old<dim>::write_gnuplot_draft (ostream &out) const
     };
 
 
-  DoFHandler<dim>::active_cell_iterator cell;
+DoFHandler<dim>::active_cell_iterator cell;
   DoFHandler<dim>::active_cell_iterator endc = dofs->end();
 
   unsigned int cell_index=0;
@@ -753,9 +746,9 @@ void DataOut_Old<dim>::write_gnuplot_draft (ostream &out) const
                  };
                                                 // again: stop drawing
                out << endl << endl;
-               
-               
-               break;
+
+
+break;
                
          default:
                Assert (false, ExcNotImplemented());
@@ -820,9 +813,9 @@ void DataOut_Old<2>::write_povray_mesh (ostream &out) const {
       << "  <20, 20, -20> White"        << endl
       << "}"                         << endl
       << endl;
-      
-      
-                                      // write frame object
+
+
+// write frame object
   out << "mesh {" << endl;
   
   DoFHandler<2>::active_cell_iterator cell;
@@ -874,7 +867,6 @@ void DataOut_Old<2>::write_povray_mesh (ostream &out) const {
 #endif
 
 
-
 template <int dim>
 void DataOut_Old<dim>::write_povray_mesh (ostream &) const {
                                   // this is for all other dimensions that
@@ -883,8 +875,6 @@ void DataOut_Old<dim>::write_povray_mesh (ostream &) const {
 };
 
 
-
-
 #if deal_II_dimension == 2
 
 template <>
@@ -911,8 +901,8 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
        << "%%BoundingBox: -5 -5 305 305" << endl;
   };  
 
-   
-                                   // Make output values local by
+
+// Make output values local by
                                    // copying them to a multiset.
                                    // Perform the necessary turn.
    const DoFHandler<2>::active_cell_iterator endc = dofs->end();
@@ -1018,7 +1008,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
    cells2.clear();
 
 
-                                   // If we want shaded output we can
+// If we want shaded output we can
                                    // do the shading now.
    if (cell_shade_p)
      {
@@ -1069,10 +1059,9 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
                                      // more, we use a trick for copying
                                      // that is significantly faster
      cells2.swap (cells);
-   
 
 
-                                   // Next we have to shift and scale
+// Next we have to shift and scale
                                    // a bit so that everything still
                                    // arrives in our bounding box of
                                    // 310x310.
@@ -1099,7 +1088,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
      };
 
 
-                                   //  Now we are ready to output...
+//  Now we are ready to output...
    for (multiset<DataOut_Old<2>::EpsCellData>::iterator c=cells.begin();
        c!=cells.end(); ++c)
      {
@@ -1140,8 +1129,6 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
 #endif
 
 
-
-
 template <int dim>
 void DataOut_Old<dim>::write_eps (ostream &,
                              const EpsOutputData &) const{
@@ -1151,8 +1138,6 @@ void DataOut_Old<dim>::write_eps (ostream &,
 };
 
 
-
-
 template <int dim>
 void DataOut_Old<dim>::write_gmv (ostream &out) const
 {
@@ -1173,7 +1158,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
       << endl;
 
 
-                                  ///////////////////////////////
+///////////////////////////////
                                   // first make up a list of used
                                   // vertices along with their
                                   // coordinates. since dofs have
@@ -1263,9 +1248,9 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
             
       out << endl;
     };
-  
 
-                                  /////////////////////////////////////
+
+/////////////////////////////////////
                                   // now for the cells. this is simpler
                                   // than the above task
   if (true)
@@ -1290,7 +1275,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
     };
 
 
-                                  ///////////////////////////////////////
+///////////////////////////////////////
                                   // data output.
   out << "variable" << endl;
 
@@ -1348,7 +1333,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
     };
 
 
-                                  // Cell data is the simplest since the order
+// Cell data is the simplest since the order
                                   // already is correct
   if (true)
     {
@@ -1374,9 +1359,6 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
   AssertThrow (out, ExcIO());
 };
 
-  
-
-
 
 template <int dim>
 void DataOut_Old<dim>::write (ostream &out,
@@ -1413,7 +1395,6 @@ void DataOut_Old<dim>::write (ostream &out,
 };
 
 
-
 template <int dim>
 string DataOut_Old<dim>::default_suffix (const OutputFormat output_format) 
 {
@@ -1440,7 +1421,6 @@ string DataOut_Old<dim>::default_suffix (const OutputFormat output_format)
            return "";
     };
 };
-  
 
 
 template <int dim>
@@ -1477,7 +1457,6 @@ string DataOut_Old<dim>::get_output_format_names () {
 };
 
 
-
 template<int dim>
 bool DataOut_Old<dim>::EpsCellData::operator < (const EpsCellData &other) const
 {
@@ -1495,7 +1474,6 @@ bool DataOut_Old<dim>::EpsCellData::operator < (const EpsCellData &other) const
 };
 
 
-
 template <int dim>
 void DataOut_Old<dim>::EpsVertexData::turn(double azi, double ele)
 {
@@ -1527,7 +1505,6 @@ void DataOut_Old<dim>::EpsVertexData::turn(double azi, double ele)
 //      (  0   0 1 )( 0 sx  cx )(z)   (  0*x+  *(cx*y-sx*z)+1*(sx*y+cx*z) )
 
 
-
 template <int dim>
 void DataOut_Old<dim>::EpsCellData::turn(double azi, double ele)
 {
@@ -1551,7 +1528,6 @@ EpsOutputData::EpsOutputData()
 };
 
 
-
 void EpsOutputData::color(const float x,
                          const float xmax,
                          const float xmin, 
@@ -1632,6 +1608,5 @@ void EpsOutputData::color(const float x,
 };
 
 
-
 //explicit instantiations
 template class DataOut_Old<deal_II_dimension>;
index c8d83e7f11f036d378c8bf21ce91109b7782e16e..3974a81bed90d731da3de4e92c661ac51cccd3e1 100644 (file)
@@ -1,4 +1,15 @@
-/* $Id$ */
+//----------------------------  data_out.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  data_out.cc  ---------------------------
 
 
 #include <base/quadrature_lib.h>
@@ -80,7 +91,6 @@ void DataOut_DoFData<dim>::add_data_vector (const Vector<double> &vec,
 };
 
 
-
 template <int dim>
 void DataOut_DoFData<dim>::add_data_vector (const Vector<double> &vec,
                                            const string         &name)
@@ -99,8 +109,6 @@ void DataOut_DoFData<dim>::add_data_vector (const Vector<double> &vec,
 }
 
 
-
-
 template <int dim>
 void DataOut_DoFData<dim>::clear ()
 {
@@ -119,7 +127,6 @@ void DataOut_DoFData<dim>::clear ()
 };
 
 
-
 template <int dim>
 vector<string> DataOut_DoFData<dim>::get_dataset_names () const 
 {
@@ -139,7 +146,6 @@ vector<string> DataOut_DoFData<dim>::get_dataset_names () const
 };
 
 
-
 template <int dim>
 const vector<typename DataOutBase::Patch<dim> > &
 DataOut_DoFData<dim>::get_patches () const
@@ -223,8 +229,6 @@ void * DataOut<dim>::build_some_patches (Data data)
 }
 
 
-
-
 template <int dim>
 void DataOut<dim>::build_patches (const unsigned int n_subdivisions,
                                  const unsigned int n_threads_) 
@@ -240,7 +244,7 @@ void DataOut<dim>::build_patches (const unsigned int n_subdivisions,
 #endif
 
 
-                                  // before we start the loop:
+// before we start the loop:
                                   // create a quadrature rule that
                                   // actually has the points on this
                                   // patch
@@ -321,7 +325,6 @@ void DataOut<dim>::build_patches (const unsigned int n_subdivisions,
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::cell_iterator
 DataOut<dim>::first_cell () 
@@ -330,7 +333,6 @@ DataOut<dim>::first_cell ()
 };
 
 
-
 template <int dim>
 typename DoFHandler<dim>::cell_iterator
 DataOut<dim>::next_cell (const typename DoFHandler<dim>::cell_iterator &cell) 
@@ -344,10 +346,8 @@ DataOut<dim>::next_cell (const typename DoFHandler<dim>::cell_iterator &cell)
 };
 
 
-
 // explicit instantiations
 template class DataOut_DoFData<deal_II_dimension>;
 template class DataOut<deal_II_dimension>;
 
 
-
index 70b23947f302b48821a934186dd1f0b912693e4e..c26d11dc1347e5187337bc95f3c1832347e5d42d 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  data_out_stack.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  data_out_stack.cc  ---------------------------
+
 
 #include <numerics/data_out_stack.h>
 #include <base/quadrature_lib.h>
@@ -15,7 +27,6 @@ DataOutStack<dim>::~DataOutStack ()
 {};
 
 
-
 template <int dim>
 void DataOutStack<dim>::new_parameter_value (const double p,
                                             const double dp)
@@ -45,7 +56,6 @@ void DataOutStack<dim>::attach_dof_handler (const DoFHandler<dim> &dof)
 };
 
 
-
 template <int dim>
 void DataOutStack<dim>::declare_data_vector (const string     &name,
                                             const VectorType  vector_type)
@@ -56,7 +66,6 @@ void DataOutStack<dim>::declare_data_vector (const string     &name,
 };
 
 
-
 template <int dim>
 void DataOutStack<dim>::declare_data_vector (const vector<string> &names,
                                             const VectorType      vector_type)
@@ -108,8 +117,6 @@ void DataOutStack<dim>::add_data_vector (const Vector<number> &vec,
 };
 
 
-
-
 template <int dim>
 template <typename number>
 void DataOutStack<dim>::add_data_vector (const Vector<number> &vec,
@@ -161,7 +168,6 @@ void DataOutStack<dim>::add_data_vector (const Vector<number> &vec,
 };
 
 
-
 template <int dim>
 void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions) 
 {
@@ -183,7 +189,7 @@ void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions)
     ++n_patches;
 
 
-                                  // before we start the loop:
+// before we start the loop:
                                   // create a quadrature rule that
                                   // actually has the points on this
                                   // patch, and an object that
@@ -231,9 +237,9 @@ void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions)
          default:
                Assert (false, ExcNotImplemented());
        };
-      
 
-                                      // now fill in the the data values.
+
+// now fill in the the data values.
                                       // note that the required order is
                                       // with highest coordinate running
                                       // fastest, we need to enter each
@@ -282,7 +288,6 @@ void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions)
 };
 
 
-
 template <int dim>
 void DataOutStack<dim>::finish_parameter_value ()
 {
@@ -296,7 +301,6 @@ void DataOutStack<dim>::finish_parameter_value ()
 };
 
 
-
 template <int dim>
 const vector<DataOutBase::Patch<dim+1> > &
 DataOutStack<dim>::get_patches () const
@@ -305,7 +309,6 @@ DataOutStack<dim>::get_patches () const
 };
 
 
-
 template <int dim>
 vector<string> DataOutStack<dim>::get_dataset_names () const
 {
@@ -321,8 +324,6 @@ vector<string> DataOutStack<dim>::get_dataset_names () const
 };
 
 
-
-
 // explicit instantiations
 template class DataOutStack<deal_II_dimension>;
 template void DataOutStack<deal_II_dimension>::add_data_vector (const Vector<double> &vec,
index 117d0c36c0b4147ee4e823b23262e14987e7354a..4541b861e0747a1dc4a139548147c2962151d56c 100644 (file)
@@ -1,4 +1,16 @@
-// $Id$
+//----------------------------  equation.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  equation.cc  ---------------------------
+
 
 #include <numerics/assembler.h>
 #include <grid/tria_iterator.h>
@@ -13,7 +25,6 @@ Equation<dim>::Equation (const unsigned int n_equations) :
                n_eq(n_equations) {};
 
 
-
 template <int dim>
 void Equation<dim>::assemble (FullMatrix<double>          &,
                              Vector<double>           &,
@@ -24,7 +35,6 @@ void Equation<dim>::assemble (FullMatrix<double>          &,
 };
 
 
-
 template <int dim>
 void Equation<dim>::assemble (FullMatrix<double>          &,
                              const FEValues<dim> &,
@@ -34,7 +44,6 @@ void Equation<dim>::assemble (FullMatrix<double>          &,
 };
 
 
-
 template <int dim>
 void Equation<dim>::assemble (Vector<double>           &,
                              const FEValues<dim> &,
@@ -44,6 +53,4 @@ void Equation<dim>::assemble (Vector<double>           &,
 };
 
 
-
-
 template class Equation<deal_II_dimension>;
index 8578460188a44a992c96b95760ef663eac80cd1e..c8d794ab9ad21d8683c8d55cdbe421ac258d3db5 100644 (file)
@@ -1,4 +1,15 @@
-/*      $Id$                 */
+//----------------------------  error_estimator.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  error_estimator.cc  ---------------------------
 
 
 #include <fe/fe.h>
@@ -135,7 +146,6 @@ void KellyErrorEstimator<1>::estimate_some (Data &, const unsigned int)
 }
 
 
-
 template <>
 void KellyErrorEstimator<1>::estimate (const DoFHandler<1>  &dof,
                                       const Quadrature<0>  &,
@@ -163,9 +173,9 @@ void KellyErrorEstimator<1>::estimate (const DoFHandler<1>  &dof,
 
   for (FunctionMap::const_iterator i=neumann_bc.begin(); i!=neumann_bc.end(); ++i)
     Assert (i->second->n_components == n_components, ExcInvalidBoundaryFunction());
-  
-  
-  const unsigned int dim=1;
+
+
+const unsigned int dim=1;
 
                                   // reserve one slot for each cell and set
                                   // it to zero
@@ -262,9 +272,9 @@ void KellyErrorEstimator<1>::estimate (const DoFHandler<1>  &dof,
                coefficient->vector_value(cell->vertex(n),
                                          coefficient_values);
            };
-         
-         
-         for (unsigned int component=0; component<n_components; ++component)
+
+
+for (unsigned int component=0; component<n_components; ++component)
            if (component_mask[component] == true)
              {
                                                 // get gradient
@@ -283,9 +293,9 @@ void KellyErrorEstimator<1>::estimate (const DoFHandler<1>  &dof,
       error(cell_index) = sqrt(error(cell_index));
     };
 };
-       
 
-                                // #if deal_II_dimension !=1
+
+// #if deal_II_dimension !=1
 #else
 
 
@@ -318,9 +328,9 @@ void KellyErrorEstimator<dim>::estimate_some (Data               &data,
   FESubfaceValues<dim> fe_subface_values (data.dof.get_fe(),
                                          data.quadrature,
                                          update_gradients);
-  
-  
-  DoFHandler<dim>::active_cell_iterator cell=data.dof.begin_active();
+
+
+DoFHandler<dim>::active_cell_iterator cell=data.dof.begin_active();
 
                                   // calculate the start cell for this
                                   // thread. the enumeration is choosen
@@ -343,9 +353,9 @@ void KellyErrorEstimator<dim>::estimate_some (Data               &data,
                                           // face: do nothing
          if (data.face_integrals[cell->face(face_no)] >=0)
            continue;
-         
-         
-                                          // if the neighboring cell is less
+
+
+// if the neighboring cell is less
                                           // refined than the present one, then
                                           // do nothing since we integrate
                                           // over the subfaces when we visit
@@ -369,10 +379,9 @@ void KellyErrorEstimator<dim>::estimate_some (Data               &data,
              data.face_integrals[cell->face(face_no)] = 0;
              continue;
            };
-         
-         
-         
-         if (cell->face(face_no)->has_children() == false)
+
+
+if (cell->face(face_no)->has_children() == false)
                                             // if the face is a regular one, i.e.
                                             // either on the other side there is
                                             // nirvana (face is at boundary), or
@@ -403,7 +412,6 @@ void KellyErrorEstimator<dim>::estimate_some (Data               &data,
 };
 
 
-
 template <int dim>
 void KellyErrorEstimator<dim>::estimate (const DoFHandler<dim>   &dof,
                                         const Quadrature<dim-1> &quadrature,
@@ -450,9 +458,9 @@ void KellyErrorEstimator<dim>::estimate (const DoFHandler<dim>   &dof,
   for (active_cell_iterator cell=data.dof.begin_active(); cell!=data.endc; ++cell)
     for (unsigned int face_no=0; face_no<GeometryInfo<dim>::faces_per_cell; ++face_no)
       data.face_integrals[cell->face(face_no)]=-10e20;
-  
-  
-                                  // split all cells into threads
+
+
+// split all cells into threads
                                   // if multithreading is used
 #ifdef DEAL_II_USE_MT
 
@@ -468,9 +476,9 @@ void KellyErrorEstimator<dim>::estimate (const DoFHandler<dim>   &dof,
   vector<FunData>
     fun_data (data.n_threads,
              FunData (data,0,&KellyErrorEstimator::estimate_some));
-  
-  
-                                   // get start cells for each thread
+
+
+// get start cells for each thread
   for (unsigned int l=0;l<data.n_threads;++l)
     {
       fun_data[l].arg2=l;
@@ -491,9 +499,9 @@ void KellyErrorEstimator<dim>::estimate (const DoFHandler<dim>   &dof,
   KellyErrorEstimator::estimate_some(data,0);
   
 #endif
-  
-  
-                                  // finally add up the contributions of the
+
+
+// finally add up the contributions of the
                                   // faces for each cell
   
                                   // reserve one slot for each cell and set
@@ -538,7 +546,6 @@ void KellyErrorEstimator<1>::integrate_over_regular_face (Data &,
 };
 
 
-
 template <>
 void KellyErrorEstimator<1>::
 integrate_over_irregular_face (Data &,
@@ -554,7 +561,6 @@ integrate_over_irregular_face (Data &,
 #endif
 
 
-
 template <int dim>
 void KellyErrorEstimator<dim>::
 integrate_over_regular_face (Data                       &data,
@@ -605,10 +611,9 @@ integrate_over_regular_face (Data                       &data,
        for (unsigned int p=0; p<data.n_q_points; ++p)
          data.psi[this_thread][p][component] -= data.neighbor_psi[this_thread][p][component];
     };
-  
-  
-  
-                                  // now psi contains the following:
+
+
+// now psi contains the following:
                                   // - for an internal face, psi=[grad u]
                                   // - for a neumann boundary face,
                                   //   psi=grad u
@@ -658,9 +663,9 @@ integrate_over_regular_face (Data                       &data,
                data.coefficient_values[this_thread][point](component);
        };
     };
-  
-  
-  if (face->at_boundary() == true)
+
+
+if (face->at_boundary() == true)
                                     // neumann boundary face. compute
                                     // difference between normal
                                     // derivative and boundary function
@@ -682,9 +687,9 @@ integrate_over_regular_face (Data                       &data,
        for (unsigned int point=0; point<data.n_q_points; ++point)
          data.phi[this_thread][point][component] -= g[point](component);
     };
-  
-  
-                                  // now phi contains the following:
+
+
+// now phi contains the following:
                                   // - for an internal face, phi=[a du/dn]
                                   // - for a neumann boundary face,
                                   //   phi=a du/dn-g
@@ -707,8 +712,6 @@ integrate_over_regular_face (Data                       &data,
 };
 
 
-
-
 template <int dim>
 void KellyErrorEstimator<dim>::
 integrate_over_irregular_face (Data                       &data,
@@ -795,9 +798,9 @@ integrate_over_irregular_face (Data                       &data,
                                       // let phi be the name of the integrand
      
       data.normal_vectors[this_thread]=fe_face_values.get_normal_vectors();
-      
-      
-      for (unsigned int component=0; component<data.n_components; ++component)
+
+
+for (unsigned int component=0; component<data.n_components; ++component)
        for (unsigned int point=0; point<data.n_q_points; ++point)
          data.phi[this_thread][point][component] =
            data.psi[this_thread][point][component]*
@@ -843,8 +846,8 @@ integrate_over_irregular_face (Data                       &data,
       data.face_integrals[neighbor_child->face(neighbor_neighbor)] = face_integral;
     };
 
-  
-                                  // finally loop over all subfaces to
+
+// finally loop over all subfaces to
                                   // collect the contributions of the
                                   // subfaces and store them with the
                                   // mother face
@@ -866,8 +869,6 @@ integrate_over_irregular_face (Data                       &data,
 };
 
 
-
-
 // explicit instantiations
 
 template class KellyErrorEstimator<deal_II_dimension>;
index 290da45e0a75ed1cb99b5d2d0316c544b40b01ae..47a1c9ed6659b25a6ed8739b8e2c2ecf3becdca4 100644 (file)
@@ -1,4 +1,16 @@
-/* $Id$ */
+//----------------------------  histogram.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  histogram.cc  ---------------------------
+
 
 #include <lac/vector.h>
 #include <numerics/histogram.h>
@@ -6,9 +18,6 @@
 #include <cmath>
 
 
-
-
-
 template <typename number>
 inline
 bool Histogram::logarithmic_less (const number n1,
@@ -20,7 +29,6 @@ bool Histogram::logarithmic_less (const number n1,
 };
 
 
-
 Histogram::Interval::Interval (const double left_point,
                               const double right_point) :
                left_point (left_point),
@@ -29,7 +37,6 @@ Histogram::Interval::Interval (const double left_point,
 {};
 
 
-
 template <typename number>
 void Histogram::evaluate (const vector<Vector<number> > &values,
                          const vector<double>          &_y_values,
@@ -87,9 +94,9 @@ void Histogram::evaluate (const vector<Vector<number> > &values,
                                     &Histogram::template logarithmic_less<number>
 #endif
            );
-           
 
-           for (unsigned int i=1; i<values.size(); ++i)
+
+for (unsigned int i=1; i<values.size(); ++i)
              {
                min_value = min (min_value,
                                 *min_element(values[i].begin(),
@@ -139,10 +146,9 @@ void Histogram::evaluate (const vector<Vector<number> > &values,
                                   // precision.
   if (max_value <= min_value)
     max_value = min_value+1;
-  
 
 
-                                  // now set up the intervals based on
+// now set up the intervals based on
                                   // the min and max values
   intervals.clear ();
                                   // set up one list of intervals
@@ -185,7 +191,7 @@ void Histogram::evaluate (const vector<Vector<number> > &values,
     intervals.push_back (intervals[0]);
 
 
-                                  // finally fill the intervals
+// finally fill the intervals
   for (unsigned int i=0; i<values.size(); ++i)
     for (Vector<number>::const_iterator p=values[i].begin();
         p < values[i].end(); ++p)
@@ -206,7 +212,6 @@ void Histogram::evaluate (const vector<Vector<number> > &values,
 };
 
 
-
 template <typename number>
 void Histogram::evaluate (const Vector<number>    &values,
                          const unsigned int       n_intervals,
@@ -218,7 +223,6 @@ void Histogram::evaluate (const Vector<number>    &values,
 };
 
 
-
 void Histogram::write_gnuplot (ostream &out) const
 {
   AssertThrow (out, ExcIO());
@@ -290,14 +294,12 @@ void Histogram::write_gnuplot (ostream &out) const
 };
 
 
-
 string Histogram::get_interval_spacing_names () 
 {
   return "linear|logarithmic";
 };
 
 
-
 Histogram::IntervalSpacing
 Histogram::parse_interval_spacing (const string &name)
 {
@@ -315,8 +317,6 @@ Histogram::parse_interval_spacing (const string &name)
 };
 
 
-
-
 // explicit instantiations for float
 template
 void Histogram::evaluate (const vector<Vector<float> >  &values,
index cc740b8155a36887ea11e880ac5796504bb68e0b..319b12197629f79bdaeeda121a84f75afc71ce59 100644 (file)
@@ -1,4 +1,16 @@
-/*      $Id$                 */
+//----------------------------  matrices.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  matrices.cc  ---------------------------
+
 
 #include <base/function.h>
 #include <dofs/dof_handler.h>
@@ -18,7 +30,6 @@
 #include <cmath>
 
 
-
 template <int dim>
 void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
                                             const Quadrature<dim>    &q,
@@ -46,8 +57,6 @@ void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
 };
 
 
-
-
 template <int dim>
 void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
                                             const Quadrature<dim>    &q,
@@ -76,7 +85,6 @@ void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
 };
 
 
-
 template <int dim>
 void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
                                             SparseMatrix<double>     &matrix) {
@@ -102,7 +110,6 @@ void MatrixCreator<dim>::create_mass_matrix (const DoFHandler<dim>    &dof,
 };
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -119,7 +126,6 @@ void MatrixCreator<1>::create_boundary_mass_matrix (const DoFHandler<1>    &,
 #endif
 
 
-
 template <int dim>
 void MatrixCreator<dim>::create_boundary_mass_matrix (const DoFHandler<dim>    &dof,
                                                      const Quadrature<dim-1>  &q,
@@ -159,9 +165,9 @@ void MatrixCreator<dim>::create_boundary_mass_matrix (const DoFHandler<dim>    &
   
   FullMatrix<double> cell_matrix(dofs_per_cell, dofs_per_cell);
   Vector<double>     cell_vector(dofs_per_cell);
-  
-  
-  UpdateFlags update_flags = UpdateFlags (update_values     |
+
+
+UpdateFlags update_flags = UpdateFlags (update_values     |
                                          update_JxW_values |
                                          update_q_points);
   FEFaceValues<dim> fe_values (fe, q, update_flags);
@@ -284,10 +290,9 @@ void MatrixCreator<dim>::create_boundary_mass_matrix (const DoFHandler<dim>    &
                                        weights[point];
                    };
            };
-         
 
 
-                                          // now transfer cell matrix and vector
+// now transfer cell matrix and vector
                                           // to the whole boundary matrix
                                           //
                                           // in the following: dof[i] holds the
@@ -399,7 +404,6 @@ void MatrixCreator<dim>::create_boundary_mass_matrix (const DoFHandler<dim>    &
 };
 
 
-
 template <int dim>
 void MatrixCreator<dim>::create_laplace_matrix (const DoFHandler<dim>    &dof,
                                                const Quadrature<dim>    &q,
@@ -496,10 +500,6 @@ void MatrixCreator<dim>::create_laplace_matrix (const DoFHandler<dim>    &dof,
 };
 
 
-
-
-
-
 template <int dim>
 void MatrixTools<dim>::apply_boundary_values (const map<unsigned int,double> &boundary_values,
                                              SparseMatrix<double>  &matrix,
@@ -515,9 +515,9 @@ void MatrixTools<dim>::apply_boundary_values (const map<unsigned int,double> &bo
                                   // simply return
   if (boundary_values.size() == 0)
     return;
-  
-  
-  map<unsigned int,double>::const_iterator  dof  = boundary_values.begin(),
+
+
+map<unsigned int,double>::const_iterator  dof  = boundary_values.begin(),
                                            endd = boundary_values.end();
   const unsigned int n_dofs             = matrix.m();
   const SparsityPattern    &sparsity    = matrix.get_sparsity_pattern();
@@ -543,8 +543,8 @@ void MatrixTools<dim>::apply_boundary_values (const map<unsigned int,double> &bo
       for (unsigned int j=sparsity_rowstart[dof_number]+1; j<last; ++j)
        matrix.global_entry(j) = 0.;
 
-      
-                                      // set right hand side to
+
+// set right hand side to
                                       // wanted value: if main diagonal
                                       // entry nonzero, don't touch it
                                       // and scale rhs accordingly. If
@@ -630,23 +630,14 @@ void MatrixTools<dim>::apply_boundary_values (const map<unsigned int,double> &bo
              matrix.global_entry(global_entry) = 0.;
            };
        };
-      
-      
-      
-                                      // preset solution vector
+
+
+// preset solution vector
       solution(dof_number) = dof->second;
     };
 };
 
 
-
-
-
-
-
-
-
-
 template <int dim>
 MassMatrix<dim>::MassMatrix (const Function<dim> * const rhs,
                             const Function<dim> * const a) :
@@ -655,7 +646,6 @@ MassMatrix<dim>::MassMatrix (const Function<dim> * const rhs,
                coefficient (a)   {};
 
 
-
 template <int dim>
 void MassMatrix<dim>::assemble (FullMatrix<double>      &cell_matrix,
                                const FEValues<dim>     &fe_values,
@@ -675,8 +665,8 @@ void MassMatrix<dim>::assemble (FullMatrix<double>      &cell_matrix,
   const FullMatrix<double> &values    = fe_values.get_shape_values ();
   const vector<double>     &weights   = fe_values.get_JxW_values ();
 
-  
-  if (coefficient != 0)
+
+if (coefficient != 0)
     {
       if (coefficient->n_components == 1)
                                         // scalar coefficient given
@@ -740,7 +730,6 @@ void MassMatrix<dim>::assemble (FullMatrix<double>      &cell_matrix,
 };
 
 
-
 template <int dim>
 void MassMatrix<dim>::assemble (FullMatrix<double>  &cell_matrix,
                                Vector<double>      &rhs,
@@ -806,7 +795,6 @@ void MassMatrix<dim>::assemble (FullMatrix<double>  &cell_matrix,
 };
 
 
-
 template <int dim>
 void MassMatrix<dim>::assemble (Vector<double>      &rhs,
                                const FEValues<dim> &fe_values,
@@ -840,9 +828,6 @@ void MassMatrix<dim>::assemble (Vector<double>      &rhs,
 };
 
 
-
-
-
 template <int dim>
 LaplaceMatrix<dim>::LaplaceMatrix (const Function<dim> * const rhs,
                                   const Function<dim> * const a) :
@@ -919,7 +904,6 @@ void LaplaceMatrix<dim>::assemble (FullMatrix<double>         &cell_matrix,
 };
 
 
-
 template <int dim>
 void LaplaceMatrix<dim>::assemble (FullMatrix<double>  &cell_matrix,
                                   const FEValues<dim> &fe_values,
@@ -974,7 +958,6 @@ void LaplaceMatrix<dim>::assemble (FullMatrix<double>  &cell_matrix,
 };
 
 
-
 template <int dim>
 void LaplaceMatrix<dim>::assemble (Vector<double>      &rhs,
                                   const FEValues<dim> &fe_values,
@@ -1009,7 +992,6 @@ void LaplaceMatrix<dim>::assemble (Vector<double>      &rhs,
 };
 
 
-
 template<int dim>
 void
 MatrixCreator<dim>::create_interpolation_matrix(const FiniteElement<dim> &high,
@@ -1025,7 +1007,7 @@ MatrixCreator<dim>::create_interpolation_matrix(const FiniteElement<dim> &high,
          ExcDimensionMismatch(result.n(), high.dofs_per_cell));
 
 
-                                  // Initialize FEValues at the support points
+// Initialize FEValues at the support points
                                   // of the low element.
   vector<double> phantom_weights(low.dofs_per_cell,1.);
   vector<Point<dim> > support_points(low.dofs_per_cell);
@@ -1045,8 +1027,6 @@ MatrixCreator<dim>::create_interpolation_matrix(const FiniteElement<dim> &high,
 }
 
 
-
-
 template class MatrixCreator<deal_II_dimension>;
 template class MatrixTools<deal_II_dimension>;
 template class MassMatrix<deal_II_dimension>;
index db66f5519ccaf10ad4e419210983badbd46e9aef..9c8555308cf93a7cf831bc6aa809f30759287495 100644 (file)
@@ -1,6 +1,16 @@
-/*----------------------------   solutiontransfer.cc     ---------------------*/
-/*      $Id$     */
-/*           Ralf Hartmann, University of Heidelberg                          */
+//----------------------------  solution_transfer.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  solution_transfer.cc  ---------------------------
+
 
 #include <grid/tria.h>
 #include <dofs/dof_handler.h>
@@ -12,7 +22,6 @@
 #include <numerics/solution_transfer.h>
 
 
-
 template<int dim, typename number>
 SolutionTransfer<dim, number>::SolutionTransfer(const DoFHandler<dim> &dof):
                dof_handler(&dof),
@@ -21,7 +30,6 @@ SolutionTransfer<dim, number>::SolutionTransfer(const DoFHandler<dim> &dof):
 {}
 
 
-
 template<int dim, typename number>
 SolutionTransfer<dim, number>::~SolutionTransfer()
 {
@@ -29,7 +37,6 @@ SolutionTransfer<dim, number>::~SolutionTransfer()
 }
 
 
-
 template<int dim, typename number>
 void SolutionTransfer<dim, number>::clear ()
 {
@@ -44,7 +51,6 @@ void SolutionTransfer<dim, number>::clear ()
 }
 
 
-
 template<int dim, typename number>
 void SolutionTransfer<dim, number>::prepare_for_pure_refinement()
 { 
@@ -87,7 +93,6 @@ void SolutionTransfer<dim, number>::prepare_for_pure_refinement()
 }
 
 
-
 template<int dim, typename number>  
 void
 SolutionTransfer<dim, number>::refine_interpolate(const Vector<number> &in,
@@ -125,7 +130,6 @@ SolutionTransfer<dim, number>::refine_interpolate(const Vector<number> &in,
 }
 
 
-
 template<int dim, typename number>  
 void SolutionTransfer<dim, number>::refine_interpolate (Vector<number> &vec) const
 {
@@ -138,7 +142,6 @@ void SolutionTransfer<dim, number>::refine_interpolate (Vector<number> &vec) con
 }
 
 
-
 template<int dim, typename number>
 void
 SolutionTransfer<dim, number>::
@@ -199,7 +202,7 @@ prepare_for_coarsening_and_refinement(const vector<Vector<number> > &all_in)
                                              n_coarsen_fathers);
 
 
-                                  // we need counters for
+// we need counters for
                                   // the 'to_stay_or_refine' cells 'n_sr',
                                   // the 'coarsen_fathers' cells 'n_cf',
                                   // and all the cells where a
@@ -256,7 +259,6 @@ prepare_for_coarsening_and_refinement(const vector<Vector<number> > &all_in)
 }
 
 
-
 template<int dim, typename number>
 void
 SolutionTransfer<dim, number>::prepare_for_coarsening_and_refinement(const Vector<number> &in)
@@ -266,7 +268,6 @@ SolutionTransfer<dim, number>::prepare_for_coarsening_and_refinement(const Vecto
 }
 
 
-
 template<int dim, typename number>
 void SolutionTransfer<dim, number>::
 interpolate (const vector<Vector<number> > &all_in,
@@ -290,8 +291,8 @@ interpolate (const vector<Vector<number> > &all_in,
          all_out[i].reinit (dof_handler->n_dofs());
     };
 
-  
-  const unsigned int dofs_per_cell=dof_handler->get_fe().dofs_per_cell;  
+
+const unsigned int dofs_per_cell=dof_handler->get_fe().dofs_per_cell;  
   Vector<number> local_values(dofs_per_cell);
 
   vector<unsigned int>    *indexptr;
@@ -351,7 +352,6 @@ interpolate (const vector<Vector<number> > &all_in,
 }
 
 
-
 template<int dim, typename number>
 void SolutionTransfer<dim, number>::interpolate(const Vector<number> &in,
                                                Vector<number>       &out) const
@@ -366,8 +366,6 @@ void SolutionTransfer<dim, number>::interpolate(const Vector<number> &in,
 }
 
 
-
-
 template class SolutionTransfer<deal_II_dimension, float>;
 template class SolutionTransfer<deal_II_dimension, double>;
 
index 3336e5f26f7ed073472e6af4d1ed42759a031817..8420d91fcf42869a166eb8a9aa1b32dbd1b408bf 100644 (file)
@@ -1,4 +1,15 @@
-// $Id$
+//----------------------------  time_dependent.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  time_dependent.cc  ---------------------------
 
 
 #include <numerics/time_dependent.h>
@@ -25,8 +36,6 @@ TimeDependent::TimeSteppingData::TimeSteppingData (const unsigned int look_ahead
 {};
 
 
-
-
 TimeDependent::TimeDependent (const TimeSteppingData &data_primal,
                              const TimeSteppingData &data_dual,
                              const TimeSteppingData &data_postprocess):
@@ -37,8 +46,6 @@ TimeDependent::TimeDependent (const TimeSteppingData &data_primal,
 {};
 
 
-
-
 TimeDependent::~TimeDependent ()
 {
   while (timesteps.size() != 0)
@@ -46,7 +53,6 @@ TimeDependent::~TimeDependent ()
 };
 
 
-
 void
 TimeDependent::insert_timestep (const TimeStepBase *position,
                                TimeStepBase       *new_timestep) 
@@ -107,7 +113,6 @@ TimeDependent::insert_timestep (const TimeStepBase *position,
 };
 
 
-
 void
 TimeDependent::add_timestep (TimeStepBase *new_timestep)
 {
@@ -115,7 +120,6 @@ TimeDependent::add_timestep (TimeStepBase *new_timestep)
 };
 
 
-
 void TimeDependent::delete_timestep (const unsigned int position)
 {
   Assert (position<timesteps.size(),
@@ -144,7 +148,6 @@ void TimeDependent::delete_timestep (const unsigned int position)
 };
 
 
-
 void
 TimeDependent::solve_primal_problem () 
 {
@@ -155,7 +158,6 @@ TimeDependent::solve_primal_problem ()
 };
 
 
-
 void
 TimeDependent::solve_dual_problem () 
 {
@@ -166,7 +168,6 @@ TimeDependent::solve_dual_problem ()
 };
 
 
-
 void
 TimeDependent::postprocess () 
 {
@@ -177,9 +178,6 @@ TimeDependent::postprocess ()
 };
 
 
-
-
-
 void TimeDependent::start_sweep (const unsigned int s) 
 {
   sweep_no = s;
@@ -202,7 +200,6 @@ void TimeDependent::start_sweep (const unsigned int s)
 };
 
 
-
 void TimeDependent::end_sweep (const unsigned int n_threads)
 {
 #ifdef DEAL_II_USE_MT
@@ -238,21 +235,17 @@ void TimeDependent::end_sweep (const unsigned int n_threads)
 }
 
 
-
 void TimeDependent::end_sweep (const unsigned int begin,
                               const unsigned int end)
 {     
   for (unsigned int step=begin; step<end; ++step)
     timesteps[step]->end_sweep ();
 };
-  
-
 
 
 /* --------------------------------------------------------------------- */
 
 
-
 TimeStepBase::TimeStepBase (const double time) :
                previous_timestep(0),
                next_timestep (0),
@@ -262,36 +255,30 @@ TimeStepBase::TimeStepBase (const double time) :
 {};
 
 
-
 TimeStepBase::~TimeStepBase () 
 {};
 
 
-
 void
 TimeStepBase::wake_up (const unsigned )
 {};
 
 
-
 void
 TimeStepBase::sleep (const unsigned)
 {};
 
 
-
 void
 TimeStepBase::start_sweep () 
 {};
 
 
-
 void
 TimeStepBase::end_sweep () 
 {};
 
 
-
 void
 TimeStepBase::init_for_primal_problem () 
 {
@@ -299,7 +286,6 @@ TimeStepBase::init_for_primal_problem ()
 };
 
 
-
 void
 TimeStepBase::init_for_dual_problem () 
 {
@@ -307,7 +293,6 @@ TimeStepBase::init_for_dual_problem ()
 };
 
 
-
 void
 TimeStepBase::init_for_postprocessing () 
 {
@@ -315,8 +300,6 @@ TimeStepBase::init_for_postprocessing ()
 };
 
 
-
-
 void
 TimeStepBase::solve_dual_problem () 
 {
@@ -324,7 +307,6 @@ TimeStepBase::solve_dual_problem ()
 };
 
 
-
 void
 TimeStepBase::postprocess_timestep () 
 {
@@ -332,7 +314,6 @@ TimeStepBase::postprocess_timestep ()
 };
 
 
-
 double
 TimeStepBase::get_time () const 
 {
@@ -340,7 +321,6 @@ TimeStepBase::get_time () const
 };
 
 
-
 unsigned int
 TimeStepBase::get_timestep_no () const 
 {
@@ -348,7 +328,6 @@ TimeStepBase::get_timestep_no () const
 };
 
 
-
 double
 TimeStepBase::get_backward_timestep () const
 {
@@ -357,7 +336,6 @@ TimeStepBase::get_backward_timestep () const
 };
 
 
-
 double
 TimeStepBase::get_forward_timestep () const
 {
@@ -366,7 +344,6 @@ TimeStepBase::get_forward_timestep () const
 };
 
 
-
 void
 TimeStepBase::set_previous_timestep (const TimeStepBase *previous)
 {
@@ -374,7 +351,6 @@ TimeStepBase::set_previous_timestep (const TimeStepBase *previous)
 };
 
 
-
 void
 TimeStepBase::set_next_timestep (const TimeStepBase *next)
 {
@@ -382,7 +358,6 @@ TimeStepBase::set_next_timestep (const TimeStepBase *next)
 };
 
 
-
 void
 TimeStepBase::set_timestep_no (const unsigned int step_no)
 {
@@ -390,7 +365,6 @@ TimeStepBase::set_timestep_no (const unsigned int step_no)
 };
 
 
-
 void
 TimeStepBase::set_sweep_no (const unsigned int sweep)
 {
@@ -398,13 +372,9 @@ TimeStepBase::set_sweep_no (const unsigned int sweep)
 };
 
 
-
 /* ------------------------------------------------------------------------- */
 
 
-
-
-
 template <int dim>
 TimeStepBase_Tria<dim>::TimeStepBase_Tria() :
                TimeStepBase (0),
@@ -415,7 +385,6 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria() :
 };
 
 
-
 template <int dim>
 TimeStepBase_Tria<dim>::TimeStepBase_Tria (const double              time,
                                           const Triangulation<dim> &coarse_grid,
@@ -431,7 +400,6 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria (const double              time,
 };
 
 
-
 template <int dim>
 TimeStepBase_Tria<dim>::~TimeStepBase_Tria () 
 {
@@ -447,7 +415,6 @@ TimeStepBase_Tria<dim>::~TimeStepBase_Tria ()
 };
 
 
-
 template <int dim>
 void
 TimeStepBase_Tria<dim>::wake_up (const unsigned wakeup_level) {
@@ -459,7 +426,6 @@ TimeStepBase_Tria<dim>::wake_up (const unsigned wakeup_level) {
 };
 
 
-
 template <int dim>
 void
 TimeStepBase_Tria<dim>::sleep (const unsigned sleep_level)
@@ -480,8 +446,6 @@ TimeStepBase_Tria<dim>::sleep (const unsigned sleep_level)
 };
 
 
-
-
 template <int dim>
 void TimeStepBase_Tria<dim>::save_refine_flags ()
 {
@@ -494,7 +458,6 @@ void TimeStepBase_Tria<dim>::save_refine_flags ()
 };
 
 
-
 template <int dim>
 void TimeStepBase_Tria<dim>::restore_grid () {
   Assert (tria == 0, ExcGridNotDeleted());
@@ -534,7 +497,6 @@ void TimeStepBase_Tria<dim>::restore_grid () {
 };
 
 
-
 template <int dim>
 static void
 mirror_refinement_flags (const Triangulation<dim>::cell_iterator &new_cell,
@@ -580,7 +542,6 @@ mirror_refinement_flags (const Triangulation<dim>::cell_iterator &new_cell,
 };
 
 
-
 template <int dim>
 static bool
 adapt_grids (const Triangulation<dim>::cell_iterator &cell1,
@@ -595,8 +556,8 @@ adapt_grids (const Triangulation<dim>::cell_iterator &cell1,
       return grids_changed;
     };
 
-  
-  if (!cell1->has_children() && !cell2->has_children())
+
+if (!cell1->has_children() && !cell2->has_children())
                                     // none of the two have children, so
                                     // make sure that not one is flagged
                                     // for refinement and the other for
@@ -616,9 +577,9 @@ adapt_grids (const Triangulation<dim>::cell_iterator &cell1,
       
       return false;
     };
-  
-  
-  if (cell1->has_children() && !cell2->has_children())
+
+
+if (cell1->has_children() && !cell2->has_children())
                                     // cell1 has children, cell2 has not
                                     // -> cell2 needs to be refined if any
                                     // of cell1's children is flagged
@@ -683,7 +644,6 @@ adapt_grids (const Triangulation<dim>::cell_iterator &cell1,
 };    
 
 
-
 template <int dim>
 static bool
 adapt_grids (Triangulation<dim> &tria1,
@@ -703,10 +663,6 @@ adapt_grids (Triangulation<dim> &tria1,
 };
 
 
-
-
-
-
 template <int dim>
 void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
 {
@@ -734,7 +690,7 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                p_coarsening_threshold=0;
 
 
-                                  // if we are to do some cell number
+// if we are to do some cell number
                                   // correction steps, we have to find out
                                   // which further cells (beyond
                                   // refinement_threshold) to refine in case
@@ -763,9 +719,8 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                            coarsening_threshold);
     };
 
-  
-  
-                                  // actually flag cells the first time
+
+// actually flag cells the first time
   tria->refine (criteria, refinement_threshold);
   tria->coarsen (criteria, coarsening_threshold);
 
@@ -832,9 +787,8 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
        tria->prepare_coarsening_and_refinement ();
        previous_tria->prepare_coarsening_and_refinement ();
 
-      
-      
-                                            // now count the number of elements
+
+// now count the number of elements
                                             // which will result on the previous
                                             // grid after it will be refined. The
                                             // number which will really result
@@ -1050,8 +1004,8 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
            cell->clear_coarsen_flag ();
          };
 
-  
-                                        // flag cells finally
+
+// flag cells finally
        tria->refine (criteria, refinement_threshold);
        tria->coarsen (criteria, coarsening_threshold);
       };
@@ -1067,9 +1021,9 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
     {
       Triangulation<dim> *previous_tria
        = dynamic_cast<const TimeStepBase_Tria<dim>*>(previous_timestep)->tria;
-       
 
-                                      // if we used the dual estimator, we
+
+// if we used the dual estimator, we
                                       // computed the error information on
                                       // a time slab, rather than on a level
                                       // of its own. we then mirror the
@@ -1105,8 +1059,6 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
 };
 
 
-
-
 template <int dim>
 void TimeStepBase_Tria<dim>::init_for_refinement () 
 {
@@ -1114,16 +1066,12 @@ void TimeStepBase_Tria<dim>::init_for_refinement ()
 };
 
 
-
-
-
 template <int dim>
 TimeStepBase_Tria<dim>::Flags::Flags () {
   Assert (false, ExcInternalError());
 };
 
 
-
 template <int dim>
 TimeStepBase_Tria<dim>::Flags::Flags (const bool delete_and_rebuild_tria,
                                      const unsigned int wakeup_level_to_build_grid,
@@ -1139,7 +1087,6 @@ TimeStepBase_Tria<dim>::Flags::Flags (const bool delete_and_rebuild_tria,
 };
 
 
-
 template <int dim>
 TimeStepBase_Tria<dim>::RefinementFlags::CorrectionRelaxations
 TimeStepBase_Tria<dim>::RefinementFlags::default_correction_relaxations 
@@ -1179,7 +1126,6 @@ RefinementFlags (const unsigned int max_refinement_level,
 };
 
 
-
 template <int dim>
 TimeStepBase_Tria<dim>::RefinementData::
 RefinementData (const double         _refinement_threshold,
@@ -1218,9 +1164,6 @@ RefinementData (const double         _refinement_threshold,
 };
 
 
-
-
-
 // explicit instantiations
 template class TimeStepBase_Tria<deal_II_dimension>;
 
index d5eaf900aa0bd581abae042e348d145eb2ce909e..7aba0b069ef8a4c167cbb099ecbc8604f5a9c95e 100644 (file)
@@ -1,5 +1,16 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  vectors.all_dimensions.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  vectors.all_dimensions.cc  ---------------------------
+
 
 #include <lac/vector.h>
 #include <numerics/vectors.h>
@@ -30,4 +41,3 @@ VectorTools::subtract_mean_value(Vector<double>     &v,
 };
 
 
-
index 54ce1406806e83a284459d0b3af7587e8d3ff3fe..4771820ac00c5b8bfbb753240355499b41dbe223 100644 (file)
@@ -1,6 +1,15 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
-
+//----------------------------  vectors.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  vectors.cc  ---------------------------
 
 
 #include <base/function.h>
@@ -27,8 +36,6 @@
 #include <cmath>
 
 
-
-
 inline double sqr (const double x) {
   return x*x;
 };
@@ -40,8 +47,6 @@ inline double sqr_point (const Tensor<1,dim> &p) {
 };
 
 
-
-
 template <int dim>
 void VectorTools::interpolate (const DoFHandler<dim> &dof,
                               const Function<dim>   &function,
@@ -237,8 +242,7 @@ void VectorTools::interpolate (const DoFHandler<dim> &dof,
       cell->get_dof_indices (dofs_on_cell);
 
 
-                                      
-      if (fe_is_system)
+if (fe_is_system)
        {
                                           // get function values at
                                           // these points. Here: get
@@ -274,7 +278,6 @@ void VectorTools::interpolate (const DoFHandler<dim> &dof,
 }
 
 
-
 template <int dim> void
 VectorTools::interpolate (const DoFHandler<dim>           &dof_1,
                          const DoFHandler<dim>           &dof_2,
@@ -325,7 +328,6 @@ VectorTools::interpolate (const DoFHandler<dim>           &dof_1,
 }
 
 
-
 #if deal_II_dimension == 1
 
 template <>
@@ -349,8 +351,6 @@ void VectorTools::project (const DoFHandler<1>    &,
 #endif
 
 
-
-
 template <int dim>
 void VectorTools::project (const DoFHandler<dim>    &dof,
                           const ConstraintMatrix   &constraints,
@@ -407,9 +407,8 @@ void VectorTools::project (const DoFHandler<dim>    &dof,
                                 boundary_values);
       };
 
-  
-      
-                                  // set up mass matrix and right hand side
+
+// set up mass matrix and right hand side
   vec.reinit (dof.n_dofs());
   SparsityPattern sparsity(dof.n_dofs(),
                           dof.n_dofs(),
@@ -456,7 +455,6 @@ void VectorTools::project (const DoFHandler<dim>    &dof,
 };
 
 
-
 template <int dim>
 void VectorTools::create_right_hand_side (const DoFHandler<dim>    &dof,
                                          const Quadrature<dim>    &quadrature,
@@ -488,8 +486,6 @@ void VectorTools::create_right_hand_side (const DoFHandler<dim>    &dof,
 };
 
 
-
-
 #if deal_II_dimension == 1
 
 template <>
@@ -574,7 +570,6 @@ VectorTools::interpolate_boundary_values (const DoFHandler<1>      &dof,
 #endif
 
 
-
 template <int dim>
 void
 VectorTools::interpolate_boundary_values (const DoFHandler<dim>    &dof,
@@ -657,7 +652,6 @@ VectorTools::interpolate_boundary_values (const DoFHandler<dim>    &dof,
 }
 
 
-
 template <int dim>
 void
 VectorTools::project_boundary_values (const DoFHandler<dim>    &dof,
@@ -697,14 +691,14 @@ VectorTools::project_boundary_values (const DoFHandler<dim>    &dof,
     sparsity.compress();
   else
     Assert (false, ExcNotImplemented());
-  
 
-                                  // make mass matrix and right hand side
+
+// make mass matrix and right hand side
   SparseMatrix<double> mass_matrix(sparsity);
   Vector<double>       rhs(sparsity.n_rows());
-  
 
-  MatrixTools<dim>::create_boundary_mass_matrix (dof, q, 
+
+MatrixTools<dim>::create_boundary_mass_matrix (dof, q, 
                                                 mass_matrix, boundary_functions,
                                                 rhs, dof_to_boundary_mapping);
 
@@ -712,8 +706,8 @@ VectorTools::project_boundary_values (const DoFHandler<dim>    &dof,
                                   // to consider constraints
   Assert (dim<3, ExcNotImplemented());
 
-  
-  Vector<double> boundary_projection (rhs.size());
+
+Vector<double> boundary_projection (rhs.size());
 
   SolverControl           control(1000, 1e-16);
   PrimitiveVectorMemory<> memory;
@@ -740,7 +734,6 @@ VectorTools::project_boundary_values (const DoFHandler<dim>    &dof,
 };
 
 
-
 template <int dim>
 void
 VectorTools::integrate_difference (const DoFHandler<dim>    &dof,
@@ -969,16 +962,14 @@ VectorTools::integrate_difference (const DoFHandler<dim>    &dof,
                Assert (false, ExcNotImplemented());
        };
 
-      
-                                      // append result of this cell
+
+// append result of this cell
                                       // to the end of the vector
       difference(index) = diff;
     };
 };
 
 
-
-
 // explicit instantiations
 template
 void VectorTools::integrate_difference (const DoFHandler<deal_II_dimension> &,

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.