]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new heads
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Feb 2000 20:16:11 +0000 (20:16 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Feb 2000 20:16:11 +0000 (20:16 +0000)
git-svn-id: https://svn.dealii.org/trunk@2475 0785d39b-7218-0410-832d-ea1e28bc413d

46 files changed:
deal.II/deal.II/include/dofs/dof_accessor.h
deal.II/deal.II/include/dofs/dof_accessor.templates.h
deal.II/deal.II/include/dofs/dof_constraints.h
deal.II/deal.II/include/dofs/dof_constraints.templates.h
deal.II/deal.II/include/dofs/dof_handler.h
deal.II/deal.II/include/dofs/dof_levels.h
deal.II/deal.II/include/dofs/dof_tools.h
deal.II/deal.II/include/grid/geometry_info.h
deal.II/deal.II/include/grid/grid_generator.h
deal.II/deal.II/include/grid/grid_in.h
deal.II/deal.II/include/grid/grid_out.h
deal.II/deal.II/include/grid/intergrid_map.h
deal.II/deal.II/include/grid/magic_numbers.h
deal.II/deal.II/include/grid/persistent_tria.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/grid/tria_accessor.h
deal.II/deal.II/include/grid/tria_accessor.templates.h
deal.II/deal.II/include/grid/tria_boundary.h
deal.II/deal.II/include/grid/tria_boundary_lib.h
deal.II/deal.II/include/grid/tria_hex.h
deal.II/deal.II/include/grid/tria_iterator.h
deal.II/deal.II/include/grid/tria_iterator.templates.h
deal.II/deal.II/include/grid/tria_iterator_base.h
deal.II/deal.II/include/grid/tria_levels.h
deal.II/deal.II/include/grid/tria_line.h
deal.II/deal.II/include/grid/tria_quad.h
deal.II/deal.II/include/multigrid/mg_base.h
deal.II/deal.II/include/multigrid/mg_dof_accessor.h
deal.II/deal.II/include/multigrid/mg_dof_handler.h
deal.II/deal.II/include/multigrid/mg_dof_tools.h
deal.II/deal.II/include/multigrid/mg_smoother.h
deal.II/deal.II/include/multigrid/mg_smoother.templates.h
deal.II/deal.II/include/multigrid/multigrid.h
deal.II/deal.II/include/multigrid/multigrid.templates.h
deal.II/deal.II/include/numerics/assembler.h
deal.II/deal.II/include/numerics/base.h
deal.II/deal.II/include/numerics/data_io.h
deal.II/deal.II/include/numerics/data_out.h
deal.II/deal.II/include/numerics/data_out_stack.h
deal.II/deal.II/include/numerics/dof_renumbering.h
deal.II/deal.II/include/numerics/error_estimator.h
deal.II/deal.II/include/numerics/histogram.h
deal.II/deal.II/include/numerics/matrices.h
deal.II/deal.II/include/numerics/solution_transfer.h
deal.II/deal.II/include/numerics/time_dependent.h
deal.II/deal.II/include/numerics/vectors.h

index bdcaedef753396a6116bd31930517c7caf852382..dc68f03a7958359feb8b33c370d396d65dccdd94 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   dof_iterator.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __dof_iterator_H
-#define __dof_iterator_H
+//----------------------------  dof_accessor.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__dof_accessor_h
+#define __deal2__dof_accessor_h
+
+
 /*----------------------------   dof_iterator.h     ---------------------------*/
 
 
@@ -18,7 +29,6 @@
 // inlining and thus faster code.
 
 
-
 /**
  * Define the basis for accessors to the degrees of freedom.
  *
@@ -113,8 +123,6 @@ class DoFAccessor
 };
 
 
-
-
 /* -------------------------------------------------------------------------- */
 
 /**
@@ -142,7 +150,6 @@ class DoFObjectAccessor_Inheritance
 };
 
 
-
 /**
  * This is a switch class which only declares a #typedef#. It is meant to
  * determine which class a #DoFObjectAccessor# class is to be derived
@@ -168,12 +175,9 @@ class DoFObjectAccessor_Inheritance<dim,dim>
 };
 
 
-
-
 /* -------------------------------------------------------------------------- */
 
 
-
 /**
  * Common template for access to the data on a line, quad, hex. Note
  * that this class is only here for documentation purposes, the actual
@@ -387,7 +391,6 @@ class DoFObjectAccessor : public DoFAccessor<dim>,
 };
 
 
-
 /**
  * Closure class.
  */
@@ -412,7 +415,6 @@ class DoFObjectAccessor<0, dim> : public DoFAccessor<dim>,
 };
 
 
-
 /**
  * Access to the degrees of freedom located on lines.
  * This class follows mainly the route laid out by the accessor library
@@ -603,7 +605,6 @@ class DoFObjectAccessor<1, dim> :  public DoFAccessor<dim>,
 };
 
 
-
 /**
  * Grant access to the degrees of freedom located on quads.
  *
@@ -779,9 +780,6 @@ class DoFObjectAccessor<2, dim> :  public DoFAccessor<dim>,
 };
 
 
-
-
-
 /**
  * Grant access to the degrees of freedom located on hexes.
  *
@@ -963,7 +961,6 @@ class DoFObjectAccessor<3, dim> :  public DoFAccessor<dim>,
 };
 
 
-
 /**
  * Grant access to the degrees of freedom on a cell. In fact, since all
  * access to the degrees of freedom has been enabled by the classes
@@ -1154,19 +1151,13 @@ class DoFCellAccessor :  public DoFObjectAccessor<dim, dim>
 };
 
 
-
-
-
 // if in optimized mode: include more templates
 #ifndef DEBUG
 #  include "dof_accessor.templates.h"
 #endif
 
 
-
-
-
 /*----------------------------   dof_iterator.h     ---------------------------*/
-/* end of #ifndef __dof_iterator_H */
+
 #endif
 /*----------------------------   dof_iterator.h     ---------------------------*/
index be6c92a6f426b8c73853066487959186526cdb94..ece1ad920f42d0e929fcec5328ddf22e2e636642 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   dof_accessor.templates.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __dof_accessor_templates_H
-#define __dof_accessor_templates_H
-/*----------------------------   dof_accessor.templates.h     ---------------------------*/
+//----------------------------  dof_accessor.templates.h  ---------------------------
+//    $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.templates.h  ---------------------------
+#ifndef __deal2__dof_accessor_templates_h
+#define __deal2__dof_accessor_templates_h
 
 
 #include <dofs/dof_accessor.h>
@@ -34,8 +43,6 @@ DoFObjectAccessor<1,dim>::dof_index (const unsigned int i) const
 };
 
 
-
-
 template <int dim>
 inline
 unsigned int
@@ -55,7 +62,6 @@ DoFObjectAccessor<1,dim>::vertex_dof_index (const unsigned int vertex,
 };
 
 
-
 template <int dim>
 inline
 void
@@ -78,7 +84,6 @@ DoFObjectAccessor<1,dim>::get_dof_indices (vector<unsigned int> &dof_indices) co
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<1,dim> >
@@ -97,7 +102,6 @@ DoFObjectAccessor<1,dim>::child (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 void
@@ -108,8 +112,6 @@ DoFObjectAccessor<1,dim>::copy_from (const DoFObjectAccessor<1,dim> &a)
 };
 
 
-
-
 /*------------------------- Functions: DoFObjectAccessor<2,dim> -----------------------*/
 
 template <int dim>
@@ -128,7 +130,6 @@ unsigned int DoFObjectAccessor<2,dim>::dof_index (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -148,7 +149,6 @@ DoFObjectAccessor<2,dim>::vertex_dof_index (const unsigned int vertex,
 };
 
 
-  
 template <int dim>
 inline
 void
@@ -176,7 +176,6 @@ DoFObjectAccessor<2,dim>::get_dof_indices (vector<unsigned int> &dof_indices) co
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<1,dim> >
@@ -194,7 +193,6 @@ DoFObjectAccessor<2,dim>::line (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<2,dim> >
@@ -213,7 +211,6 @@ DoFObjectAccessor<2,dim>::child (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 void
@@ -224,8 +221,6 @@ DoFObjectAccessor<2,dim>::copy_from (const DoFObjectAccessor<2,dim> &a)
 };
 
 
-
-
 /*------------------------- Functions: DoFObjectAccessor<2,dim> -----------------------*/
 
 
@@ -246,7 +241,6 @@ DoFObjectAccessor<3,dim>::dof_index (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -266,7 +260,6 @@ DoFObjectAccessor<3,dim>::vertex_dof_index (const unsigned int vertex,
 };
 
 
-  
 template <int dim>
 inline
 void
@@ -299,7 +292,6 @@ DoFObjectAccessor<3,dim>::get_dof_indices (vector<unsigned int> &dof_indices) co
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<1,dim> >
@@ -316,7 +308,6 @@ DoFObjectAccessor<3,dim>::line (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<2,dim> >
@@ -334,7 +325,6 @@ DoFObjectAccessor<3,dim>::quad (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFObjectAccessor<3,dim> >
@@ -353,7 +343,6 @@ DoFObjectAccessor<3,dim>::child (const unsigned int i) const
 };
 
 
-
 template <int dim>
 void DoFObjectAccessor<3,dim>::copy_from (const DoFObjectAccessor<3,dim> &a)
 {
@@ -362,8 +351,6 @@ void DoFObjectAccessor<3,dim>::copy_from (const DoFObjectAccessor<3,dim> &a)
 };
 
 
-
-
 /*------------------------- Functions: DoFCellAccessor -----------------------*/
 
 
@@ -385,7 +372,6 @@ DoFCellAccessor<dim>::neighbor (const unsigned int i) const
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,DoFCellAccessor<dim> >
@@ -404,12 +390,4 @@ DoFCellAccessor<dim>::child (const unsigned int i) const
 };
 
 
-
-
-
-
-
-/*----------------------------   dof_accessor.templates.h     ---------------------------*/
-/* end of #ifndef __dof_accessor_templates_H */
 #endif
-/*----------------------------   dof_accessor.templates.h     ---------------------------*/
index b7755103f5b74d32e537e401474bce457aea631f..98ecb50dd12a0e9b2d6a91f481fd7f85a9f3ee89 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   dof_constraints.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __dof_constraints_H
-#define __dof_constraints_H
-/*----------------------------   dof_constraints.h     ---------------------------*/
+//----------------------------  dof_constraints.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__dof_constraints_h
+#define __deal2__dof_constraints_h
 
 
 #include <vector>
@@ -13,7 +21,6 @@
 #include <lac/forward_declarations.h>
 
 
-
 /**
  * This class represents the matrix denoting the distribution of the degrees
  * of freedom of hanging nodes.
@@ -101,7 +108,7 @@ class ConstraintMatrix : public Subscriptor
     ConstraintMatrix ();
 
 
-                                    /**
+/**
                                      * Add a new line to the matrix.
                                      */
     void add_line (const unsigned int line);
@@ -187,7 +194,7 @@ class ConstraintMatrix : public Subscriptor
                   SparsityPattern       &condensed) const;
 
 
-                                    /**
+/**
                                      * This function does much the same as
                                      * the above one, except that it condenses
                                      * the matrix struct 'in-place'. It does
@@ -274,8 +281,8 @@ class ConstraintMatrix : public Subscriptor
     template<typename number>
     void set_zero (Vector<number> &vec) const;
 
-    
-                                    /**
+
+/**
                                      * Print the constraint lines. Mainly for
                                      * debugging purposes.
                                      *
@@ -290,7 +297,7 @@ class ConstraintMatrix : public Subscriptor
     void print (ostream &) const;
 
 
-                                    /**
+/**
                                      * Exception
                                      */
     DeclException0 (ExcMatrixIsClosed);
@@ -397,9 +404,4 @@ class ConstraintMatrix : public Subscriptor
 };
 
 
-
-
-/*----------------------------   dof_constraints.h     ---------------------------*/
-/* end of #ifndef __dof_constraints_H */
 #endif
-/*----------------------------   dof_constraints.h     ---------------------------*/
index cce8e27ab8c4eb90f23beb0cd7bc210b92308ab2..6e5f9eda8666cb749e780000d3e6a9147a7aadc6 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   dof_constraints.templates.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __dof_constraints_templates_H
-#define __dof_constraints_templates_H
-/*----------------------------   dof_constraints.templates.h     ---------------------------*/
+//----------------------------  dof_constraints.templates.h  ---------------------------
+//    $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.templates.h  ---------------------------
+#ifndef __deal2__dof_constraints_templates_h
+#define __deal2__dof_constraints_templates_h
 
 
 #include <dofs/dof_constraints.h>
@@ -63,8 +72,8 @@ ConstraintMatrix::condense (const SparseMatrix<number> &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
@@ -134,7 +143,6 @@ ConstraintMatrix::condense (const SparseMatrix<number> &uncondensed,
 };
 
 
-
 template<typename number>
 void
 ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
@@ -251,10 +259,6 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
 };
 
 
-
-
-
-
 template<typename number>
 void
 ConstraintMatrix::condense (const Vector<number> &uncondensed,
@@ -301,8 +305,8 @@ ConstraintMatrix::condense (const Vector<number> &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
@@ -356,7 +360,6 @@ ConstraintMatrix::condense (Vector<number> &vec) const
          break;
       };
 };
-  
 
 
 template<typename number>
@@ -382,7 +385,6 @@ ConstraintMatrix::set_zero (Vector<number> &vec) const
          break;
       };
 };
-  
 
 
 template<typename number>
@@ -431,8 +433,8 @@ ConstraintMatrix::distribute (const Vector<number> &condensed,
       else
        old_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
@@ -477,10 +479,4 @@ ConstraintMatrix::distribute (Vector<number> &vec) const
 };
 
 
-
-
-
-/*----------------------------   dof_constraints.templates.h     ---------------------------*/
-/* end of #ifndef __dof_constraints_templates_H */
 #endif
-/*----------------------------   dof_constraints.templates.h     ---------------------------*/
index c60f51712952483a251582f1103da3f46ea3687c..67cc4a3b178ddee0ef2ded0f42d6706a7fb11686 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   dof.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __dof_H
-#define __dof_H
+//----------------------------  dof_handler.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__dof_handler_h
+#define __deal2__dof_handler_h
+
+
 /*----------------------------   dof.h     ---------------------------*/
 
 #include <vector>
 #include <lac/forward_declarations.h>
 
 
-
-
-
-
-
 /**
  * Define some types which differ between the dimensions. This class
  * is analogous to the \Ref{TriaDimensionInfo} class hierarchy.
@@ -30,9 +36,6 @@ template <int dim>
 class DoFDimensionInfo;
 
 
-
-
-
 /**
  * Define some types for the DoF handling in one dimension.
  *
@@ -62,10 +65,6 @@ class DoFDimensionInfo<1> {
 };
 
 
-
-
-
-
 /**
  * Define some types for the DoF handling in two dimensions.
  *
@@ -95,7 +94,6 @@ class DoFDimensionInfo<2> {
 };
 
 
-
 /**
  * Define some types for the DoF handling in two dimensions.
  *
@@ -125,11 +123,6 @@ class DoFDimensionInfo<3> {
 };
 
 
-
-
-
-
-
 /**
  * Manage the distribution and numbering of the degrees of freedom for
  * non-multigrid algorithms.
@@ -726,8 +719,8 @@ class DoFHandler  :  public Subscriptor,
     active_face_iterator last_active_face (const unsigned int level) const;
                                     //@}
 
-    
-                                    /*---------------------------------------*/
+
+/*---------------------------------------*/
 
                                     /**
                                      *  @name Line iterator functions
@@ -786,7 +779,7 @@ class DoFHandler  :  public Subscriptor,
     active_line_iterator end_active_line (const unsigned int level) const;
 
 
-                                    /**
+/**
                                      *  Return an iterator pointing to the
                                      *  last line, used or not.
                                      */
@@ -883,7 +876,7 @@ class DoFHandler  :  public Subscriptor,
     active_quad_iterator end_active_quad (const unsigned int level) const;
 
 
-                                    /**
+/**
                                      *  Return an iterator pointing to the
                                      *  last quad, used or not.
                                      */
@@ -1030,7 +1023,7 @@ class DoFHandler  :  public Subscriptor,
                                     /*---------------------------------------*/
 
 
-                                    /**
+/**
                                      * Return number of degrees of freedom.
                                      * Included in this number are those
                                      * DoFs which are constrained by
@@ -1205,8 +1198,8 @@ class DoFHandler  :  public Subscriptor,
                                      * of freedom located at vertices.
                                      */
     vector<unsigned int>      vertex_dofs;
-    
-    
+
+
 #if (__GNUC__==2) && (__GNUC_MINOR__ < 95)
                                     // this seems to be disallowed
                                     // by the standard, so gcc2.95
@@ -1223,10 +1216,6 @@ class DoFHandler  :  public Subscriptor,
 };
 
 
-
-
-
-
 /* ----------------------- Inline functions ---------------------------------- */
 
 
@@ -1238,7 +1227,6 @@ unsigned int DoFHandler<dim>::n_dofs () const
 };
 
 
-
 template <int dim>
 inline
 const FiniteElement<dim> & DoFHandler<dim>::get_fe () const
@@ -1247,11 +1235,7 @@ const FiniteElement<dim> & DoFHandler<dim>::get_fe () const
 };
 
 
-
-
-
-
 /*----------------------------   dof.h     ---------------------------*/
-/* end of #ifndef __dof_H */
+
 #endif
 /*----------------------------   dof.h     ---------------------------*/
index c749c012e8c17a257dd36db59a728ece58d596f3..4bbdab445c507e0e44f16fbff311634be1d4520d 100644 (file)
@@ -1,10 +1,17 @@
-/*----------------------------   dof_levels.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __dof_levels_H
-#define __dof_levels_H
-/*----------------------------   dof_levels.h     ---------------------------*/
-
+//----------------------------  dof_levels.h  ---------------------------
+//    $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_levels.h  ---------------------------
+#ifndef __deal2__dof_levels_h
+#define __deal2__dof_levels_h
 
 
 #include <vector>
@@ -27,9 +34,6 @@ class DoFLevel
 };
 
 
-
-
-
 /**
  * Store the indices of the degrees of freedom which are located on the lines.
  *
@@ -85,8 +89,6 @@ class DoFLevel<1>
 };
 
 
-
-
 /**
  * Store the indices of the degrees of freedom which are located on quads.
  * See \Ref{DoFLevel<1>} for more information.
@@ -102,7 +104,6 @@ class DoFLevel<2> : public DoFLevel<1> {
 };
 
 
-
 /**
  * Store the indices of the degrees of freedom which are located on hexhedra.
  * See \Ref{DoFLevel<1>} for more information.
@@ -118,8 +119,4 @@ class DoFLevel<3> : public DoFLevel<2> {
 };
 
 
-
-/*----------------------------   dof_levels.h     ---------------------------*/
-/* end of #ifndef __dof_levels_H */
 #endif
-/*----------------------------   dof_levels.h     ---------------------------*/
index 466e2be19fde372192c89d0a61b439072408c042..5bcb95a0a46bd1c6611c1734047b6c91712db638 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   dof_tools.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __dof_tools_H
-#define __dof_tools_H
-/*----------------------------   dof_tools.h     ---------------------------*/
+//----------------------------  dof_tools.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__dof_tools_h
+#define __deal2__dof_tools_h
+
+
 // Copyright Wolfgang Bangerth, Guido Kanschat, and others 1999
 
 
@@ -10,7 +21,6 @@
 #include <vector>
 
 
-
 /**
  * This is a collection of functions operating on, and manipulating
  * the numbers of degrees of freedom. The documentation of the member
@@ -378,9 +388,4 @@ class DoFTools
 };
 
 
-
-
-/*----------------------------   dof_tools.h     ---------------------------*/
-/* end of #ifndef __dof_tools_H */
 #endif
-/*----------------------------   dof_tools.h     ---------------------------*/
index a69159cccc637adb2390dccb707dfe5aca2ec205..3daae3e46c9d27bf5830a05def2e1a42684ea833 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   geometry_info.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __geometry_info_H
-#define __geometry_info_H
-/*----------------------------   geometry_info.h     ---------------------------*/
+//----------------------------  geometry_info.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__geometry_info_h
+#define __deal2__geometry_info_h
 
 
 #include <base/exceptions.h>
@@ -182,7 +190,6 @@ struct GeometryInfo
 };
 
 
-
 /*---------------------------- Inline functions --------------------------------*/
 
 template<>
@@ -219,8 +226,4 @@ unsigned int GeometryInfo<3>::child_cell_on_face (const unsigned int face,
 };
 
 
-
-/*----------------------------   geometry_info.h     ---------------------------*/
-/* end of #ifndef __geometry_info_H */
 #endif
-/*----------------------------   geometry_info.h     ---------------------------*/
index 16deca0395d9429bfd23544383e2d14480359dca..2766019c0b344a2a154ef307b83048bf04285a60 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   grid_generator.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __grid_generator_H
-#define __grid_generator_H
-/*----------------------------   grid_generator.h     ---------------------------*/
+//----------------------------  grid_generator.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__grid_generator_h
+#define __deal2__grid_generator_h
 
 
 #include <base/forward_declarations.h>
@@ -10,8 +19,6 @@
 #include <base/exceptions.h>
 
 
-
-
 /**
  * This class offers triangulations of some standard domains such as hypercubes,
  * hyperball and the like. Following is a list of domains that can be generated
@@ -178,9 +185,4 @@ class GridGenerator
 };
 
 
-
-
-/*----------------------------   grid_generator.h     ---------------------------*/
-/* end of #ifndef __grid_generator_H */
 #endif
-/*----------------------------   grid_generator.h     ---------------------------*/
index d827974552a2b53251115afa927e70e6babe24db..fee29e5cd0717988b27327cb2311cfceca3cc214 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   grid_in.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __grid_in_H
-#define __grid_in_H
-/*----------------------------   grid_in.h     ---------------------------*/
-
+//----------------------------  grid_in.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__grid_in_h
+#define __deal2__grid_in_h
 
 
 #include <base/exceptions.h>
@@ -14,7 +22,6 @@
 #include <string>
 
 
-
 /**
  * This class implements an input mechanism for grid data. It allows to
  * read a grid structure into a triangulation object. Future versions
@@ -178,11 +185,4 @@ class GridIn
 };
 
 
-
-
-
-
-/*----------------------------   grid_in.h     ---------------------------*/
-/* end of #ifndef __grid_in_H */
 #endif
-/*----------------------------   grid_in.h     ---------------------------*/
index 92cbafbadfab5b8aa6d8847c8b99fa6b12d871a0..a64027718c864d0e7a818ee1596b08c1bae7ba1d 100644 (file)
@@ -1,15 +1,24 @@
-/*----------------------------   grid_out.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __grid_out_H
-#define __grid_out_H
-/*----------------------------   grid_out.h     ---------------------------*/
+//----------------------------  grid_out.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__grid_out_h
+#define __deal2__grid_out_h
+
 
 #include <grid/forward_declarations.h>
 #include <base/exceptions.h>
 #include <string>
 
 
-
 /**
  * This class provides a means to output a triangulation to a file in different
  * formats. Presently provided are functions to write it in GNUPLOT and
@@ -204,7 +213,7 @@ class GridOut
     };
 
 
-                                    /**
+/**
                                      * Flags describing the details of
                                      * output in GNUPLOT format.
                                      */
@@ -302,9 +311,9 @@ class GridOut
                      const unsigned int size       = 300,
                      const double       line_width = 0.5);
     };
-    
-       
-                                    /**
+
+
+/**
                                      * Flags describing the details of
                                      * output for encapsulated postscript
                                      * for all dimensions not explicitely
@@ -360,10 +369,9 @@ class GridOut
 //#else
 //#   warning Not implemented for gcc2.95
 //#endif
-    
-       
-    
-                                    /**
+
+
+/**
                                      * Declaration of a name for each of the
                                      * different output formats.
                                      */
@@ -490,7 +498,7 @@ class GridOut
     static string get_output_format_names ();
 
 
-                                    /**
+/**
                                      * Exception
                                      */
     DeclException0 (ExcInvalidState);
@@ -538,10 +546,9 @@ class GridOut
                                      * function.
                                      */
     EpsFlags<3>  eps_flags_3;
-    
-    
 
-                                    /**
+
+/**
                                      * Write the grid information about
                                      * faces to #out#. Only those faces
                                      * are printed which are on the boundary
@@ -593,9 +600,4 @@ class GridOut
 };
 
 
-
-
-/*----------------------------   grid_out.h     ---------------------------*/
-/* end of #ifndef __grid_out_H */
 #endif
-/*----------------------------   grid_out.h     ---------------------------*/
index e07c6768f9ac30ed6cb1bb905b973d5fb2b329e6..bc0bd22ddf41c32b14eee4f9fdac941d04e955cb 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   intergrid_map.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __intergrid_map_H
-#define __intergrid_map_H
-/*----------------------------   intergrid_map.h     ---------------------------*/
-
+//----------------------------  intergrid_map.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__intergrid_map_h
+#define __deal2__intergrid_map_h
 
 
 /**
@@ -194,8 +202,4 @@ class InterGridMap
 };
 
 
-
-/*----------------------------   intergrid_map.h     ---------------------------*/
-/* end of #ifndef __intergrid_map_H */
 #endif
-/*----------------------------   intergrid_map.h     ---------------------------*/
index 0982b811c8a4a79658a35f7fff12e5ca28518ae6..b6cfe71801a6d84835227a294a6a15858ba69d36 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   magic_numbers.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __magic_numbers_H
-#define __magic_numbers_H
-/*----------------------------   magic_numbers.h     ---------------------------*/
+//----------------------------  magic_numbers.h  ---------------------------
+//    $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.
+//
+//----------------------------  magic_numbers.h  ---------------------------
+#ifndef __deal2__magic_numbers_h
+#define __deal2__magic_numbers_h
 
 
 // This is a list of magic numbers used throughout the library.
@@ -26,8 +34,4 @@ const unsigned int mn_persistent_tria_flags_begin= 0xa200;
 const unsigned int mn_persistent_tria_flags_end  = 0xa201;
 
 
-
-/*----------------------------   magic_numbers.h     ---------------------------*/
-/* end of #ifndef __magic_numbers_H */
 #endif
-/*----------------------------   magic_numbers.h     ---------------------------*/
index 90ae33a9d5d7adf6fbf99b93ebd14c5d436e9758..b1f22a8f6cc93e4f80e480f59a44adc6daa58779 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   persistent_tria.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __persistent_tria_H
-#define __persistent_tria_H
-/*----------------------------   persistent_tria.h     ---------------------------*/
+//----------------------------  persistent_tria.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__persistent_tria_h
+#define __deal2__persistent_tria_h
 
 
 #include <base/smartpointer.h>
@@ -223,8 +232,4 @@ class PersistentTriangulation : public Triangulation<dim>
 };
 
 
-
-/*----------------------------   persistent_tria.h     ---------------------------*/
-/* end of #ifndef __persistent_tria_H */
 #endif
-/*----------------------------   persistent_tria.h     ---------------------------*/
index 7540c12a74ff7f4887aebd253661f7a969211dc9..71da673fcf8d2780259c44a87090505045ef2384 100644 (file)
@@ -1,9 +1,18 @@
-/*----------------------------   tria.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998, 1999 */
-#ifndef __tria_H
-#define __tria_H
-/*----------------------------   tria.h     ---------------------------*/
+//----------------------------  tria.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__tria_h
+#define __deal2__tria_h
+
 
 #include <vector>
 #include <grid/forward_declarations.h>
@@ -35,16 +44,6 @@ enum MeshSmoothing {
       maximum_smoothing                  = 0xffff
 };
 
-                                      
-
-
-
-    
-
-
-
-
-
 
 /*------------------------------------------------------------------------*/
 
@@ -65,9 +64,6 @@ struct CellData {
 };
 
 
-
-
-
 /**
  *  Structure to be passed to the #Triangulation<dim>::create_triangulation#
  *  function to describe boundary information.
@@ -123,15 +119,9 @@ struct SubCellData {
 };
 
 
-
-
 /*------------------------------------------------------------------------*/
 
 
-
-
-
-
 /**
  *  This class implements some types which differ between the dimensions.
  *  Declare it to have a template parameter, but do not actually declare
@@ -141,7 +131,6 @@ template <int dim>
 class TriaDimensionInfo;
 
 
-
 /**
  *  This class implements some types which differ between the dimensions.
  *  These are the declararions for the 1D case only.
@@ -250,8 +239,6 @@ class TriaDimensionInfo<2> {
 };
 
 
-
-
 /**
  *  This class implements some types which differ between the dimensions.
  *  These are the declararions for the 3D case only.
@@ -294,7 +281,6 @@ class TriaDimensionInfo<3> {
 };
 
 
-
 /*------------------------------------------------------------------------*/
 
 /**
@@ -367,7 +353,6 @@ struct TriaNumberCache<1>
 };
 
 
-
 /**
  * Cache class used to store the number of used and active elements
  * (lines or quads etc) within the levels of a triangulation. This
@@ -421,7 +406,6 @@ struct TriaNumberCache<2> : public TriaNumberCache<1>
 };
 
 
-
 /**
  * Cache class used to store the number of used and active elements
  * (lines or quads etc) within the levels of a triangulation. This
@@ -475,8 +459,6 @@ struct TriaNumberCache<3> : public TriaNumberCache<2>
 };
 
 
-
-
 /*------------------------------------------------------------------------*/
 
 
@@ -1796,9 +1778,9 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                      */
     void distort_random (const double factor,
                         const bool   keep_boundary=true);
-    
-                                     
-                                    /**
+
+
+/**
                                      *  @name Mesh refinement
                                      */
                                     /*@{*/
@@ -2059,7 +2041,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                     /*@}*/
 
 
-                                    /**
+/**
                                      *  @name User flag handling
                                      */
                                     /*@{*/
@@ -2242,8 +2224,8 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                      */
     active_cell_iterator end_active (const unsigned int level) const;
 
-    
-                                    /**
+
+/**
                                      *  Return an iterator pointing to the
                                      *  last cell, used or not.
                                      *
@@ -2424,8 +2406,8 @@ class Triangulation : public TriaDimensionInfo<dim>,
     active_face_iterator last_active_face (const unsigned int level) const;
                                     /*@}*/
 
-    
-                                    /*---------------------------------------*/
+
+/*---------------------------------------*/
 
                                     /**
                                      *  @name Line iterator functions
@@ -2905,7 +2887,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                     /*@}*/
 
 
-                                    /**
+/**
                                      *  @name Exceptions
                                      */
                                     /*@{*/
@@ -3131,8 +3113,8 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                      */
     void update_number_cache_hexes ();
 
-    
-                                    /**
+
+/**
                                      *  Array of pointers pointing to the
                                      *  #TriangulationLevel<dim># objects
                                      *  storing the data on the different
@@ -3223,15 +3205,6 @@ class Triangulation : public TriaDimensionInfo<dim>,
 };
 
 
-
-
-
-
-/*----------------------------   tria.h     ---------------------------*/
-/* end of #ifndef __tria_H */
 #endif
-/*----------------------------   tria.h     ---------------------------*/
-
-
 
 
index 29a92ffbebe2520217a072262912cb7ab6b0894f..4b5f455258cb650d57948f45e71d5b788f893175 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   tria_accessor.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_accessor_H
-#define __tria_accessor_H
-/*----------------------------   tria_accessor.h     ---------------------------*/
+//----------------------------  tria_accessor.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__tria_accessor_h
+#define __deal2__tria_accessor_h
 
 
 #include <base/exceptions.h>
 // inlining and thus faster code.
 
 
-
-
-
-
 /**
  *   Implements the accessor class descibed in the documentation of
  *   the iterator classes (see \Ref{TriaRawIterator}.
@@ -62,8 +66,7 @@ class TriaAccessor
                    tria (parent) {};
 
 
-       
-                                    /**
+/**
                                      *  Copy operator. Since this is only
                                      *  called from iterators, do not
                                      *  return anything, since the
@@ -239,7 +242,6 @@ class TriaAccessor
 };
 
 
-
 /**
  * Common template for line, quad, hex accessors.
  * According to #celldim# objects of this class represent lines,
@@ -616,7 +618,6 @@ class TriaObjectAccessor :  public TriaAccessor<dim>
 };
 
 
-
 /**
  * Closure class to stop induction of classes. Should never be called and thus
  * producesan error when created.
@@ -646,8 +647,6 @@ class TriaObjectAccessor<0, dim> : public TriaAccessor<dim>
 };
 
 
-
-
 /**
  *   Accessor to dereference the data of lines. This accessor is used to
  *   point to lines in #dim# space dimensions. There is a derived class
@@ -933,9 +932,8 @@ class TriaObjectAccessor<1, dim> :  public TriaAccessor<dim>
                                      */
     void operator = (const TriaObjectAccessor<1, dim> &);
 
-    
 
-  protected:
+protected:
     
                                     /**@name Advancement of iterators*/
                                     /*@{*/
@@ -971,7 +969,6 @@ class TriaObjectAccessor<1, dim> :  public TriaAccessor<dim>
 };
 
 
-
 /**
  *   Accessor to dereference the data of quads. This accessor is used to
  *   point to quads in #dim# space dimensions (only #dim>=2# seems reasonable
@@ -1334,7 +1331,6 @@ class TriaObjectAccessor<2, dim> :  public TriaAccessor<dim>
 };
 
 
-
 /**
  *   Accessor to dereference the data of hexahedra. This accessor is used to
  *   point to hexs in #dim# space dimensions (only #dim>=3# seems reasonable
@@ -1699,10 +1695,6 @@ class TriaObjectAccessor<3, dim> :  public TriaAccessor<dim>
 };
 
 
-
-
-
-
 /**
  * This class allows access to a cell: a line in one dimension, a quad
  * in two dimension, etc.
@@ -1826,7 +1818,7 @@ class CellAccessor :  public TriaObjectAccessor<dim,dim>
     void clear_refine_flag () const;
 
 
-                                    /**
+/**
                                      *  Return whether the coarsen flag
                                      *  is set or not.
                                      */
@@ -1912,19 +1904,12 @@ class CellAccessor :  public TriaObjectAccessor<dim,dim>
 };
 
 
-
 // if in optimized mode: include more templates
 #ifndef DEBUG
 #  include "tria_accessor.templates.h"
 #endif
 
 
-/*----------------------------   tria_accessor.h     ---------------------------*/
-/* end of #ifndef __tria_accessor_H */
 #endif
-/*----------------------------   tria_accessor.h     ---------------------------*/
-
-
-
 
 
index 569c6664af3b9abf4927b5a2a9fad13706ea9ffa..c6280835c2f0a6162550847e2f8c23269b4c5e6a 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   tria_accessor.templates.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __tria_accessor_templates_H
-#define __tria_accessor_templates_H
-/*----------------------------   tria_accessor.templates.h     ---------------------------*/
+//----------------------------  tria_accessor.templates.h  ---------------------------
+//    $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.templates.h  ---------------------------
+#ifndef __deal2__tria_accessor_templates_h
+#define __deal2__tria_accessor_templates_h
 
 
 #include <grid/tria.h>
@@ -27,7 +36,6 @@ TriaAccessor<dim>::copy_from (const TriaAccessor<dim> &a) {
   tria = a.tria;
 };
 
 
 template <int dim>
 inline
@@ -39,7 +47,6 @@ TriaAccessor<dim>::operator == (const TriaAccessor<dim> &a) const {
 };
 
 
-
 template <int dim>
 inline
 bool
@@ -50,7 +57,6 @@ TriaAccessor<dim>::operator != (const TriaAccessor<dim> &a) const {
 };
 
 
-
 template <int dim>
 inline
 int
@@ -59,14 +65,12 @@ TriaAccessor<dim>::level () const {
 };
 
 
-  
 template <int dim>
 inline
 int
 TriaAccessor<dim>::index () const {
   return present_index;
 };
-  
 
 
 template <int dim>
@@ -83,7 +87,6 @@ TriaAccessor<dim>::state () const {
 };
 
 
-
 template <int dim>
 inline
 const Triangulation<dim> &
@@ -93,12 +96,9 @@ TriaAccessor<dim>::get_triangulation () const
 };
 
 
-
 /*------------------------ Functions: LineAccessor ---------------------------*/
 
 
-
-
 template <int dim>
 inline
 bool
@@ -108,8 +108,6 @@ TriaObjectAccessor<1,dim>::used () const {
 };
 
 
-
-
 template <int dim>
 inline
 bool
@@ -119,7 +117,6 @@ TriaObjectAccessor<1,dim>::user_flag_set () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -129,7 +126,6 @@ TriaObjectAccessor<1,dim>::set_user_flag () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -139,8 +135,6 @@ TriaObjectAccessor<1,dim>::clear_user_flag () const {
 };
 
 
-
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<1,dim> >
@@ -157,7 +151,6 @@ TriaObjectAccessor<1,dim>::child (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 int
@@ -167,8 +160,6 @@ TriaObjectAccessor<1,dim>::child_index (unsigned int i) const {
 };
 
 
-
-
 template <int dim>
 inline
 bool
@@ -178,7 +169,6 @@ TriaObjectAccessor<1,dim>::has_children () const {
 }
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -191,8 +181,6 @@ TriaObjectAccessor<1,dim>::max_refinement_depth () const
                                   child(1)->max_refinement_depth() + 1  };
   return max (depths[0], depths[1]);
 };
-      
-           
 
 
 template <int dim>
@@ -221,7 +209,6 @@ TriaObjectAccessor<1,dim>::operator ++ () {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -246,12 +233,9 @@ TriaObjectAccessor<1,dim>::operator -- () {
 };
 
 
-
-
 /*------------------------ Functions: QuadAccessor ---------------------------*/
 
 
-
 template <int dim>
 inline
 bool
@@ -261,8 +245,6 @@ TriaObjectAccessor<2,dim>::used () const {
 };
 
 
-
-
 template <int dim>
 inline
 bool
@@ -272,7 +254,6 @@ TriaObjectAccessor<2,dim>::user_flag_set () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -282,7 +263,6 @@ TriaObjectAccessor<2,dim>::set_user_flag () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -292,8 +272,6 @@ TriaObjectAccessor<2,dim>::clear_user_flag () const {
 };
 
 
-
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<1,dim> >
@@ -308,7 +286,6 @@ TriaObjectAccessor<2,dim>::line (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -319,7 +296,6 @@ TriaObjectAccessor<2,dim>::line_index (unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<2,dim> >
@@ -336,7 +312,6 @@ TriaObjectAccessor<2,dim>::child (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 int TriaObjectAccessor<2,dim>::child_index (unsigned int i) const {
@@ -345,8 +320,6 @@ int TriaObjectAccessor<2,dim>::child_index (unsigned int i) const {
 };
 
 
-
-
 template <int dim>
 inline
 bool
@@ -356,7 +329,6 @@ TriaObjectAccessor<2,dim>::has_children () const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -374,7 +346,6 @@ TriaObjectAccessor<2,dim>::max_refinement_depth () const
 };
 
 
-
 template <int dim>
 inline
 void
@@ -400,7 +371,6 @@ TriaObjectAccessor<2,dim>::operator ++ () {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -425,12 +395,9 @@ TriaObjectAccessor<2,dim>::operator -- () {
 };
 
 
-
-
 /*------------------------ Functions: HexAccessor ---------------------------*/
 
 
-
 template <int dim>
 inline
 bool
@@ -440,7 +407,6 @@ TriaObjectAccessor<3,dim>::used () const {
 };
 
 
-
 template <int dim>
 inline
 bool
@@ -450,7 +416,6 @@ TriaObjectAccessor<3,dim>::user_flag_set () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -460,7 +425,6 @@ TriaObjectAccessor<3,dim>::set_user_flag () const {
 };
 
 
-
 template <int dim>
 inline
 void TriaObjectAccessor<3,dim>::clear_user_flag () const {
@@ -469,8 +433,6 @@ void TriaObjectAccessor<3,dim>::clear_user_flag () const {
 };
 
 
-
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<1,dim> >
@@ -508,7 +470,6 @@ TriaObjectAccessor<3,dim>::line (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<2,dim> >
@@ -524,7 +485,6 @@ TriaObjectAccessor<3,dim>::quad (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -553,7 +513,6 @@ TriaObjectAccessor<3,dim>::line_index (unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -564,7 +523,6 @@ TriaObjectAccessor<3,dim>::quad_index (unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<3,dim> >
@@ -581,7 +539,6 @@ TriaObjectAccessor<3,dim>::child (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 int TriaObjectAccessor<3,dim>::child_index (unsigned int i) const {
@@ -590,7 +547,6 @@ int TriaObjectAccessor<3,dim>::child_index (unsigned int i) const {
 };
 
 
-
 template <int dim>
 bool TriaObjectAccessor<3,dim>::has_children () const {
   Assert (state() == valid, ExcDereferenceInvalidObject());
@@ -598,7 +554,6 @@ bool TriaObjectAccessor<3,dim>::has_children () const {
 };
 
 
-
 template <int dim>
 inline
 unsigned int
@@ -622,7 +577,6 @@ TriaObjectAccessor<3,dim>::max_refinement_depth () const
 };
 
 
-
 template <int dim>
 inline
 void
@@ -648,7 +602,6 @@ TriaObjectAccessor<3,dim>::operator ++ () {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -673,12 +626,9 @@ TriaObjectAccessor<3,dim>::operator -- () {
 };
 
 
-
-
 /*------------------------ Functions: TriaObjectAccessor ---------------------------*/
 
 
-
 template <int celldim, int dim>
 inline
 bool
@@ -689,7 +639,6 @@ TriaObjectAccessor<celldim,dim>::used () const
 };
 
 
-
 template<int celldim, int dim>
 inline
 bool
@@ -700,7 +649,6 @@ TriaObjectAccessor<celldim,dim>::user_flag_set () const
 };
 
 
-
 template<int celldim, int dim>
 inline
 void
@@ -711,7 +659,6 @@ TriaObjectAccessor<celldim,dim>::set_user_flag () const
 };
 
 
-
 template<int celldim, int dim>
 inline
 void TriaObjectAccessor<celldim,dim>::clear_user_flag () const
@@ -721,8 +668,6 @@ void TriaObjectAccessor<celldim,dim>::clear_user_flag () const
 };
 
 
-
-
 template<int celldim, int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<1,dim> >
@@ -769,7 +714,6 @@ TriaObjectAccessor<celldim,dim>::line (const unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<2,dim> >
@@ -788,7 +732,6 @@ TriaObjectAccessor<celldim,dim>::quad (const unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 inline
 unsigned int
@@ -828,7 +771,6 @@ TriaObjectAccessor<celldim,dim>::line_index (unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 inline
 unsigned int
@@ -841,7 +783,6 @@ TriaObjectAccessor<celldim,dim>::quad_index (unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 inline
 TriaIterator<dim,TriaObjectAccessor<celldim,dim> >
@@ -860,7 +801,6 @@ TriaObjectAccessor<celldim,dim>::child (const unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 inline
 int TriaObjectAccessor<celldim,dim>::child_index (unsigned int i) const
@@ -871,7 +811,6 @@ int TriaObjectAccessor<celldim,dim>::child_index (unsigned int i) const
 };
 
 
-
 template<int celldim, int dim>
 bool TriaObjectAccessor<celldim,dim>::has_children () const
 {
@@ -880,7 +819,6 @@ bool TriaObjectAccessor<celldim,dim>::has_children () const
 };
 
 
-
 template<int celldim, int dim>
 inline
 unsigned int
@@ -904,7 +842,6 @@ TriaObjectAccessor<celldim,dim>::max_refinement_depth () const
 };
 
 
-
 template<int celldim, int dim>
 inline
 void
@@ -930,7 +867,6 @@ TriaObjectAccessor<celldim,dim>::operator ++ () {
 };
 
 
-
 template<int celldim, int dim>
 inline
 void
@@ -956,8 +892,6 @@ TriaObjectAccessor<celldim,dim>::operator -- ()
 };
 
 
-
-
 /*------------------------ Functions: CellAccessor<dim> -----------------------*/
 
 
@@ -970,7 +904,6 @@ CellAccessor<1>::face (const unsigned int) const {
 };
 
 
-
 template <>
 inline
 Triangulation<2>::face_iterator
@@ -979,7 +912,6 @@ CellAccessor<2>::face (const unsigned int i) const {
 };
 
 
-
 template <>
 inline
 Triangulation<3>::face_iterator
@@ -988,7 +920,6 @@ CellAccessor<3>::face (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 int
@@ -1000,7 +931,6 @@ CellAccessor<dim>::neighbor_index (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 int
@@ -1012,8 +942,6 @@ CellAccessor<dim>::neighbor_level (const unsigned int i) const {
 };
 
 
-
-
 template <int dim>
 inline
 bool
@@ -1030,7 +958,6 @@ CellAccessor<dim>::refine_flag_set () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -1042,7 +969,6 @@ CellAccessor<dim>::set_refine_flag () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -1052,7 +978,6 @@ CellAccessor<dim>::clear_refine_flag () const {
 };
 
 
-
 template <int dim>
 inline
 bool
@@ -1069,7 +994,6 @@ CellAccessor<dim>::coarsen_flag_set () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -1081,7 +1005,6 @@ CellAccessor<dim>::set_coarsen_flag () const {
 };
 
 
-
 template <int dim>
 inline
 void
@@ -1091,7 +1014,6 @@ CellAccessor<dim>::clear_coarsen_flag () const {
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,CellAccessor<dim> >
@@ -1106,7 +1028,6 @@ CellAccessor<dim>::neighbor (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 TriaIterator<dim,CellAccessor<dim> >
@@ -1121,7 +1042,6 @@ CellAccessor<dim>::child (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 inline
 bool
@@ -1130,11 +1050,4 @@ CellAccessor<dim>::active () const {
 };
 
 
-
-
-
-
-/*----------------------------   tria_accessor.templates.h     ---------------------------*/
-/* end of #ifndef __tria_accessor_templates_H */
 #endif
-/*----------------------------   tria_accessor.templates.h     ---------------------------*/
index 233564c814ed712966490ad2eb1c6bf885ca8d21..4d0ed02d824577132f4dcadac88a02ac1af0316e 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   boundary-function.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_boundary_H
-#define __tria_boundary_H
+//----------------------------  tria_boundary.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__tria_boundary_h
+#define __deal2__tria_boundary_h
+
+
 /*----------------------------   boundary-function.h     ---------------------------*/
 
 #include <base/point.h>
@@ -11,7 +22,6 @@
 #include <grid/forward_declarations.h>
 
 
-
 /**
  *   This class is used to represent a boundary to a triangulation.
  *   When a triangulation creates a new vertex on the boundary of the
@@ -113,9 +123,6 @@ class Boundary : public Subscriptor {
 };
 
 
-
-
-
 /**
  *   Specialisation of \Ref{Boundary}<dim>, which places the new point right
  *   into the middle of the given points. The middle is defined as the
@@ -156,10 +163,7 @@ class StraightBoundary : public Boundary<dim> {
 };
 
 
-
-
-
 /*----------------------------   boundary-function.h     ---------------------------*/
-/* end of #ifndef __tria_boundary_H */
+
 #endif
 /*----------------------------   boundary-function.h     ---------------------------*/
index 5d17dcc0da891bb24f6af48cbecd9beca2a2378d..b91976235052017b2ffc6fc37794a67f67a1830d 100644 (file)
@@ -1,15 +1,22 @@
-/*----------------------------   tria_boundary_lib.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __tria_boundary_lib_H
-#define __tria_boundary_lib_H
-/*----------------------------   tria_boundary_lib.h     ---------------------------*/
+//----------------------------  tria_boundary_lib.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__tria_boundary_lib_h
+#define __deal2__tria_boundary_lib_h
 
 
 #include <grid/tria_boundary.h>
 
 
-
-
 /**
  *   Specialisation of \Ref{Boundary}<dim>, which places the new point on
  *   the boundary of a ball in arbitrary dimension. It works by projecting
@@ -73,7 +80,6 @@ class HyperBallBoundary : public StraightBoundary<dim> {
 };
 
 
-
 /**
  * Variant of #HyperBallBoundary# which denotes a half hyper ball
  * where the first coordinate is restricted to the range $x>=0$ (or
@@ -108,8 +114,6 @@ class HalfHyperBallBoundary : public HyperBallBoundary<dim> {
     get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const;
 };
 
-    
-
 
 /**
  * Class describing the boundaries of a hyper shell. Only the center
@@ -150,9 +154,4 @@ class HyperShellBoundary : public StraightBoundary<dim>
 };
 
 
-
-
-/*----------------------------   tria_boundary_lib.h     ---------------------------*/
-/* end of #ifndef __tria_boundary_lib_H */
 #endif
-/*----------------------------   tria_boundary_lib.h     ---------------------------*/
index 186af1ac3605f4516b15c9d1c7367667069c6c27..386936591eaaf8d39034dbde5e05d3133db5a8e4 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   tria_hex.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __tria_hex_H
-#define __tria_hex_H
-/*----------------------------   tria_hex.h     ---------------------------*/
-
+//----------------------------  tria_hex.h  ---------------------------
+//    $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_hex.h  ---------------------------
+#ifndef __deal2__tria_hex_h
+#define __deal2__tria_hex_h
 
 
 #include <base/exceptions.h>
@@ -67,8 +75,6 @@ class Hexahedron {
 };
 
 
-
-
 /*----------------------------- Inline Function: Hexahedron ------------------------*/
 
 
@@ -85,7 +91,6 @@ Hexahedron::Hexahedron (const int i0, const int i1,
 };
 
 
-
 inline
 int Hexahedron::quad (const int i) const {
   Assert ((i>=0) && (i<6),
@@ -94,7 +99,6 @@ int Hexahedron::quad (const int i) const {
 };
 
 
-
 inline
 void Hexahedron::set_quad (const int i, const int index) {
   Assert ((i>=0) && (i<6),
@@ -103,9 +107,4 @@ void Hexahedron::set_quad (const int i, const int index) {
 };
 
 
-
-
-/*----------------------------   tria_hex.h     ---------------------------*/
-/* end of #ifndef __tria_hex_H */
 #endif
-/*----------------------------   tria_hex.h     ---------------------------*/
index 19cc636837a56e33950043d0220df3569ab9d209..d54fdd6fb2224c3b698790e51d96c868b235f921 100644 (file)
@@ -1,11 +1,21 @@
-/*----------------------------   tria-iterator.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_iterator_H
-#define __tria_iterator_H
-/*----------------------------   tria-iterator.h     ---------------------------*/
+//----------------------------  tria_iterator.h  ---------------------------
+//    $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_iterator.h  ---------------------------
+#ifndef __deal2__tria_iterator_h
+#define __deal2__tria_iterator_h
 
 
+/*----------------------------   tria-iterator.h     ---------------------------*/
+
 
 #include <iterator>
 #include <iostream>
@@ -21,9 +31,6 @@
 // inlining and thus faster code.
 
 
-
-
-
 /**
  *   This class implements an iterator, analogous to those of the standard
  *   template library (STL). It fulfills the requirements of a bidirectional iterator.
@@ -446,9 +453,8 @@ class TriaRawIterator : public bidirectional_iterator<Accessor,int> {
                                      */
     void print (ostream &out) const;
 
-    
-    
-                                    /**@name Exceptions*/
+
+/**@name Exceptions*/
                                     /*@{*/
                                     /**
                                      *  Exception
@@ -471,7 +477,7 @@ class TriaRawIterator : public bidirectional_iterator<Accessor,int> {
     Accessor accessor;
 
 
-                                    /**
+/**
                                      * Make all other iterator class templates
                                      * friends of this class. This is
                                      * necessary for the implementation of
@@ -490,11 +496,6 @@ class TriaRawIterator : public bidirectional_iterator<Accessor,int> {
 };
 
 
-
-
-
-
-
 /**
  *   This specialization of \Ref{TriaRawIterator} provides access only to the
  *   {\it used} lines, quads, cells, etc.
@@ -640,11 +641,6 @@ class TriaIterator : public TriaRawIterator<dim,Accessor> {
 };
 
 
-
-
-
-
-
 /**
  *   This specialization of \Ref{TriaIterator} provides access only to the
  *   {\it active} lines, quads, cells, etc. An active cell is a cell which is not
@@ -811,14 +807,9 @@ class TriaActiveIterator : public TriaIterator<dim,Accessor> {
 };
 
 
-
-
-
-
 /*----------------------- Inline functions -------------------*/
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (const Accessor &a) :
@@ -826,7 +817,6 @@ TriaRawIterator<dim,Accessor>::TriaRawIterator (const Accessor &a) :
 {};
 
 
-
 template <int dim, typename Accessor>
 template <typename OtherAccessor>
 inline
@@ -835,7 +825,6 @@ TriaRawIterator<dim,Accessor>::TriaRawIterator (const TriaRawIterator<dim,OtherA
 {};
 
 
-
 template <int dim, typename Accessor>
 inline
 const Accessor &
@@ -845,8 +834,6 @@ TriaRawIterator<dim,Accessor>::operator * () const {
 };
 
 
-
-
 template <int dim, typename Accessor>
 inline
 Accessor &
@@ -856,7 +843,6 @@ TriaRawIterator<dim,Accessor>::operator * () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 const Accessor *
@@ -865,7 +851,6 @@ TriaRawIterator<dim,Accessor>::operator -> () const {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 Accessor *
@@ -874,8 +859,6 @@ TriaRawIterator<dim,Accessor>::operator -> () {
 };
 
 
-
-
 template <int dim, typename Accessor>
 inline
 IteratorState
@@ -884,7 +867,6 @@ TriaRawIterator<dim,Accessor>::state () const {
 };
 
 
-
 // sorry that the declaration of this function looks so ragged; I had
 // to do it this way since otherwise doc++ could not parse it correctly.
 template <int dim, typename Accessor>
@@ -905,7 +887,6 @@ TriaRawIterator<dim,Accessor>::operator < (const TriaRawIterator &i) const {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor> &
@@ -917,7 +898,6 @@ TriaRawIterator<dim,Accessor>::operator ++ () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor> &
@@ -929,7 +909,6 @@ TriaRawIterator<dim,Accessor>::operator -- () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 void
@@ -938,7 +917,6 @@ TriaRawIterator<dim,Accessor>::print (ostream &out) const {
 };
 
 
-
 template <int dim, typename Accessor>
 template <typename OtherAccessor>
 inline
@@ -947,7 +925,6 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaIterator<dim,OtherAccessor>
 {};
 
 
-
 template <int dim, typename Accessor>
 template <typename OtherAccessor>
 inline
@@ -968,7 +945,6 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaRawIterator<dim,OtherAccesso
 };
 
 
-
 template <int dim, typename Accessor>
 template <typename OtherAccessor>
 inline
@@ -977,7 +953,6 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaActiveIterator<d
 {};
 
 
-
 template <int dim, typename Accessor>
 template <typename OtherAccessor>
 inline
@@ -998,9 +973,6 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaRawIterator<dim,
 };
 
 
-
-
-
 template <int dim, typename Accessor>
 inline
 ostream & operator << (ostream &out, const TriaRawIterator<dim,Accessor> &i) {
@@ -1009,7 +981,6 @@ ostream & operator << (ostream &out, const TriaRawIterator<dim,Accessor> &i) {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 ostream & operator << (ostream &out, const TriaIterator<dim,Accessor> &i) {
@@ -1018,7 +989,6 @@ ostream & operator << (ostream &out, const TriaIterator<dim,Accessor> &i) {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 ostream & operator << (ostream &out, const TriaActiveIterator<dim,Accessor> &i) {
@@ -1027,7 +997,6 @@ ostream & operator << (ostream &out, const TriaActiveIterator<dim,Accessor> &i)
 };
 
 
-
 // if in optimized mode: include more templates
 #ifndef DEBUG
 #  include "tria_iterator.templates.h"
@@ -1035,7 +1004,7 @@ ostream & operator << (ostream &out, const TriaActiveIterator<dim,Accessor> &i)
 
 
 /*----------------------------   tria-iterator.h     ---------------------------*/
-/* end of #ifndef __tria_iterator_H */
+
 #endif
 /*----------------------------   tria-iterator.h     ---------------------------*/
 
index 70f2024830643127885a8a4644886223059973dc..e22cae5eb30c810987de63817e382f03c5ba0e40 100644 (file)
@@ -1,9 +1,18 @@
-/*----------------------------   tria_iterator.templates.h     ---------------------------*/
-/*      Copyright W. Bangerth, University of Heidelberg, 1998                             */
-/*      $Id$                 */
-#ifndef __tria_iterator_templates_H
-#define __tria_iterator_templates_H
-/*----------------------------   tria_iterator.templates.h     ---------------------------*/
+//----------------------------  tria_iterator.templates.h  ---------------------------
+//    $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_iterator.templates.h  ---------------------------
+#ifndef __deal2__tria_iterator_templates_h
+#define __deal2__tria_iterator_templates_h
+
 
 #include <grid/tria.h>
 #include <grid/tria_iterator.h>
@@ -15,7 +24,6 @@
 */
 
 
-
 /*------------------------ Functions: TriaRawIterator ------------------*/
 
 
@@ -25,14 +33,12 @@ TriaRawIterator<dim,Accessor>::TriaRawIterator () :
                accessor (0, -2, -2, 0) {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (const TriaRawIterator<dim,Accessor> &i) :
                accessor (i.accessor) {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (Triangulation<dim> *parent,
@@ -42,7 +48,6 @@ TriaRawIterator<dim,Accessor>::TriaRawIterator (Triangulation<dim> *parent,
                accessor (parent, level, index, local_data) {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor> &
@@ -53,7 +58,6 @@ TriaRawIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor> &
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 bool
@@ -62,7 +66,6 @@ TriaRawIterator<dim,Accessor>::operator == (const TriaRawIterator<dim,Accessor>
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 bool
@@ -82,7 +85,6 @@ TriaRawIterator<dim,Accessor>::operator != (const TriaRawIterator<dim,Accessor>
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>
@@ -94,7 +96,6 @@ TriaRawIterator<dim,Accessor>::operator ++ (int) {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>
@@ -106,8 +107,6 @@ TriaRawIterator<dim,Accessor>::operator -- (int) {
 };
 
 
-
-
 /*-----------------------  functions: TriaIterator ---------------*/
 
 
@@ -123,7 +122,6 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaIterator<dim,Accessor> &i) :
                TriaRawIterator<dim,Accessor> (static_cast<TriaRawIterator<dim,Accessor> >(i)) {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor>::TriaIterator (const TriaRawIterator<dim,Accessor> &i) :
@@ -143,7 +141,6 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaRawIterator<dim,Accessor> &i
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor>::TriaIterator (Triangulation<dim> *parent,
@@ -166,7 +163,6 @@ TriaIterator<dim,Accessor>::TriaIterator (Triangulation<dim> *parent,
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor> &
@@ -196,7 +192,6 @@ TriaIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor> &i)
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor> & TriaIterator<dim,Accessor>::operator ++ () {
@@ -208,7 +203,6 @@ TriaIterator<dim,Accessor> & TriaIterator<dim,Accessor>::operator ++ () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor>  TriaIterator<dim,Accessor>::operator ++ (int) {
@@ -219,7 +213,6 @@ TriaIterator<dim,Accessor>  TriaIterator<dim,Accessor>::operator ++ (int) {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor> &
@@ -243,7 +236,6 @@ TriaIterator<dim,Accessor>::operator -- (int) {
 };
 
 
-
 /*-----------------------  functions: TriaActiveIterator ---------------*/
 
 
@@ -253,14 +245,12 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator () :
                TriaIterator<dim,Accessor> () {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaActiveIterator<dim,Accessor> &i) :
                TriaIterator<dim,Accessor> (static_cast<TriaIterator<dim,Accessor> >(i)) {};
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaRawIterator<dim,Accessor> &i) :
@@ -299,7 +289,6 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaIterator<dim,Acc
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator (Triangulation<dim> *parent,
@@ -322,7 +311,6 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (Triangulation<dim> *parent
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> &
@@ -332,7 +320,6 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaActiveIterator<dim,Acces
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> &
@@ -353,7 +340,6 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> &
@@ -374,7 +360,6 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaIterator<dim,Accessor> &
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> &
@@ -387,7 +372,6 @@ TriaActiveIterator<dim,Accessor>::operator ++ () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>
@@ -399,7 +383,6 @@ TriaActiveIterator<dim,Accessor>::operator ++ (int) {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> &
@@ -412,7 +395,6 @@ TriaActiveIterator<dim,Accessor>::operator -- () {
 };
 
 
-
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor> TriaActiveIterator<dim,Accessor>::operator -- (int) {
@@ -423,9 +405,4 @@ TriaActiveIterator<dim,Accessor> TriaActiveIterator<dim,Accessor>::operator -- (
 };
 
 
-
-
-/*----------------------------   tria_iterator.templates.h     ---------------------------*/
-/* end of #ifndef __tria_iterator_templates_H */
 #endif
-/*----------------------------   tria_iterator.templates.h     ---------------------------*/
index 696b38426efd66738eecb140d7801a804378ff90..5d1c999498fbe7a36337be1b39ce53322655783e 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   tria_iterator_base.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __tria_iterator_base_H
-#define __tria_iterator_base_H
-/*----------------------------   tria_iterator_base.h     ---------------------------*/
+//----------------------------  tria_iterator_base.h  ---------------------------
+//    $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_iterator_base.h  ---------------------------
+#ifndef __deal2__tria_iterator_base_h
+#define __deal2__tria_iterator_base_h
 
 
 /**
@@ -16,8 +25,4 @@ enum IteratorState {
 };
 
 
-
-/*----------------------------   tria_iterator_base.h     ---------------------------*/
-/* end of #ifndef __tria_iterator_base_H */
 #endif
-/*----------------------------   tria_iterator_base.h     ---------------------------*/
index d7c30b0acafa66675fccc40c4f83fcfe39911993..b7444a186c98e723e494d1fd356a2b9f66d0e0a2 100644 (file)
@@ -1,10 +1,17 @@
-/*----------------------------   tria_levels.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_levels_H
-#define __tria_levels_H
-/*----------------------------   tria_levels.h     ---------------------------*/
-
+//----------------------------  tria_levels.h  ---------------------------
+//    $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_levels.h  ---------------------------
+#ifndef __deal2__tria_levels_h
+#define __deal2__tria_levels_h
 
 
 #include <vector>
@@ -168,7 +175,6 @@ class TriangulationLevel<0> {
 };
 
 
-
 /**
  *  Store all information which belongs to one level of the multilevel hierarchy.
  *  
@@ -314,8 +320,6 @@ class TriangulationLevel<1> : public TriangulationLevel<0> {
 };
 
 
-
-
 /**
  *  Store all information which belongs to one level of the multilevel hierarchy.
  *
@@ -388,8 +392,8 @@ class TriangulationLevel<2> :  public TriangulationLevel<1>
                                          */
        vector<unsigned char> material_id;
 
-    
-                                        /**
+
+/**
                                          * Pointer which is not used by the
                                          * library but may be accessed an set
                                          * by the user to handle data local to
@@ -422,8 +426,6 @@ class TriangulationLevel<2> :  public TriangulationLevel<1>
 };
 
 
-
-
 /**
  *  Store all information which belongs to one level of the multilevel hierarchy.
  *
@@ -496,8 +498,8 @@ class TriangulationLevel<3> :  public TriangulationLevel<2>
                                          */
        vector<unsigned char> material_id;
 
-    
-                                        /**
+
+/**
                                          * Pointer which is not used by the
                                          * library but may be accessed an set
                                          * by the user to handle data local to
@@ -530,9 +532,4 @@ class TriangulationLevel<3> :  public TriangulationLevel<2>
 };
 
 
-
-
-/*----------------------------   tria_levels.h     ---------------------------*/
-/* end of #ifndef __tria_levels_H */
 #endif
-/*----------------------------   tria_levels.h     ---------------------------*/
index e4eec3876c2a36073879340bda72b07eeea2ddd3..79e3fac16834d7d94155d043410f6e6ea12c8ecd 100644 (file)
@@ -1,9 +1,18 @@
-/*----------------------------   tria_line.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_line_H
-#define __tria_line_H
-/*----------------------------   tria_line.h     ---------------------------*/
+//----------------------------  tria_line.h  ---------------------------
+//    $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_line.h  ---------------------------
+#ifndef __deal2__tria_line_h
+#define __deal2__tria_line_h
+
 
 #include <base/exceptions.h>
 
@@ -58,8 +67,6 @@ class Line {
 };
 
 
-
-
 /*----------------------------- Inline Function: Line ------------------------*/
 
 
@@ -86,8 +93,4 @@ void Line::set_vertex (const int i, const int index) {
 };
 
 
-
-/*----------------------------   tria_line.h     ---------------------------*/
-/* end of #ifndef __tria_line_H */
 #endif
-/*----------------------------   tria_line.h     ---------------------------*/
index 0fddc1bbb5d8a140d4c674b07dc7a94242bdc586..4a996f909e29707ef82bbbbd179e5bed92fb2be5 100644 (file)
@@ -1,16 +1,22 @@
-/*----------------------------   tria_quad.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __tria_quad_H
-#define __tria_quad_H
-/*----------------------------   tria_quad.h     ---------------------------*/
+//----------------------------  tria_quad.h  ---------------------------
+//    $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_quad.h  ---------------------------
+#ifndef __deal2__tria_quad_h
+#define __deal2__tria_quad_h
 
 
 #include <base/exceptions.h>
 
 
-
-
 /**
  *   #Quad#s denote the fundamental entities of triangulations in two dimensions
  *   and the boundaries of hexaeders in three dimensions. They are
@@ -65,8 +71,6 @@ class Quad {
 };
 
 
-
-
 /*----------------------------- Inline Function: Quad ------------------------*/
 
 
@@ -79,7 +83,6 @@ Quad::Quad (const int i0, const int i1, const int i2, const int i3) {
 };
 
 
-
 inline
 int Quad::line (const int i) const {
   Assert ((i>=0) && (i<4),
@@ -88,7 +91,6 @@ int Quad::line (const int i) const {
 };
 
 
-
 inline
 void Quad::set_line (const int i, const int index) {
   Assert ((i>=0) && (i<4),
@@ -97,8 +99,4 @@ void Quad::set_line (const int i, const int index) {
 };
 
 
-
-/*----------------------------   tria_quad.h     ---------------------------*/
-/* end of #ifndef __tria_quad_H */
 #endif
-/*----------------------------   tria_quad.h     ---------------------------*/
index ccc5e91787a1df6268d1c40ee29b07be8872d465..4d6b2e755e88149e9e0c3824c2af520c1c5273dc 100644 (file)
@@ -1,10 +1,21 @@
-/*----------------------------   mgbase.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __mgbase_H
-#define __mgbase_H
-/*----------------------------   mgbase.h     ---------------------------*/
+//----------------------------  mg_base.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__mg_base_h
+#define __deal2__mg_base_h
 
 
+/*----------------------------   mgbase.h     ---------------------------*/
+
 
 #include <base/subscriptor.h>
 #include <base/smartpointer.h>
@@ -16,8 +27,6 @@
 #include <vector>
 
 
-
-
 /**
  * An array with an object for each level.  The purpose of this class
  * is mostly to allow access by level number, even if the lower levels
@@ -99,9 +108,6 @@ class MGLevelObject : public Subscriptor
 };
 
 
-
-
-
 /**
  * Abstract base class for coarse grid solvers.  The interface of a
  * function call operator is defined to execute coarse grid solution
@@ -136,7 +142,6 @@ class MGCoarseGridSolver : public Subscriptor
 };
 
 
-
 /**
  * Coarse grid solver using LAC iterative methods.
  * This is a little wrapper, transforming a triplet of iterative
@@ -190,11 +195,6 @@ class MGCoarseGridLACIteration :  public MGCoarseGridSolver
 };
 
 
-
-
-
-
-
 /**
  * Base class used to declare the operations needed by a concrete class
  * implementing prolongation and restriction of vectors in the multigrid
@@ -260,12 +260,6 @@ class MGTransferBase : public Subscriptor
 };
 
 
-
-
-
-
-
-
 /**
  * Basic class for preconditioning by multigrid.
  *
@@ -406,7 +400,6 @@ class MGBase : public Subscriptor
 };
 
 
-
 /**
  * Multi-level preconditioner.
  * Here, we collect all information needed for multi-level preconditioning
@@ -469,8 +462,6 @@ class PreconditionMG
 };
 
 
-
-
 /* ------------------------------------------------------------------- */
 
 
@@ -484,7 +475,6 @@ MGLevelObject<Object>::MGLevelObject(const unsigned int min,
 };
 
 
-
 template<class Object>
 Object &
 MGLevelObject<Object>::operator[] (const unsigned int i)
@@ -505,7 +495,6 @@ MGLevelObject<Object>::operator[] (const unsigned int i) const
 }
 
 
-
 template<class Object>
 void
 MGLevelObject<Object>::resize (const unsigned int new_minlevel,
@@ -519,7 +508,6 @@ MGLevelObject<Object>::resize (const unsigned int new_minlevel,
 };
 
 
-
 template<class Object>
 void
 MGLevelObject<Object>::clear ()
@@ -538,7 +526,6 @@ MGLevelObject<Object>::get_minlevel () const
 };
 
 
-
 template<class Object>
 unsigned int
 MGLevelObject<Object>::get_maxlevel () const
@@ -547,7 +534,6 @@ MGLevelObject<Object>::get_maxlevel () const
 };
 
 
-
 /* ------------------ Functions for MGCoarseGridLACIteration ------------ */
 
 
@@ -562,7 +548,6 @@ MGCoarseGridLACIteration<SOLVER,MATRIX,PRECOND>::MGCoarseGridLACIteration(SOLVER
 {};
 
 
-
 template<class SOLVER, class MATRIX, class PRECOND>
 void
 MGCoarseGridLACIteration<SOLVER,MATRIX,PRECOND>::operator() (const unsigned int    /* level */,
@@ -573,10 +558,6 @@ MGCoarseGridLACIteration<SOLVER,MATRIX,PRECOND>::operator() (const unsigned int
 }
 
 
-
-
-
-
 /* ------------------------------------------------------------------- */
 
 
@@ -593,7 +574,6 @@ PreconditionMG<MG, VECTOR>::PreconditionMG(MG                       &mg,
 {}
 
 
-
 template<class MG, class VECTOR>
 void
 PreconditionMG<MG,VECTOR>::operator() (VECTOR       &dst,
@@ -605,8 +585,7 @@ PreconditionMG<MG,VECTOR>::operator() (VECTOR       &dst,
 }
 
 
-
 /*----------------------------   mgbase.h     ---------------------------*/
-/* end of #ifndef __mgbase_H */
+
 #endif
 /*----------------------------   mgbase.h     ---------------------------*/
index 05f401412ef943685ba8ce2b5d597c1cf58b9100..bd9eb7900893a19e6507c61b5ba7336abbb29020 100644 (file)
@@ -1,16 +1,22 @@
-/*----------------------------   mg_dof_accessor.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __mg_dof_accessor_H
-#define __mg_dof_accessor_H
-/*----------------------------   mg_dof_accessor.h     ---------------------------*/
+//----------------------------  mg_dof_accessor.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__mg_dof_accessor_h
+#define __deal2__mg_dof_accessor_h
 
 
 #include <dofs/dof_accessor.h>
 
 
-
-
 /**
  * Define the basis for accessors to the degrees of freedom for
  * a multigrid DoF handler object.
@@ -116,7 +122,6 @@ class MGDoFObjectAccessor_Inheritance
 };
 
 
-
 /**
  * This is a switch class which only declares a #typdef#. It is meant to
  * determine which class a #DoFObjectAccessor# class is to be derived
@@ -142,12 +147,9 @@ class MGDoFObjectAccessor_Inheritance<dim,dim>
 };
 
 
-
-
 /* -------------------------------------------------------------------------- */
 
 
-
 /**
  * Common template for line, quad, hex.
  *
@@ -161,7 +163,6 @@ class MGDoFObjectAccessor :  public MGDoFAccessor<dim>,
 {};
 
 
-
 /**
  * Closure class.
  */
@@ -185,7 +186,6 @@ class MGDoFObjectAccessor<0, dim>
 };
 
 
-
 /**
  * Grant access to the degrees of freedom located on lines.
  * This class follows mainly the route laid out by the accessor library
@@ -326,10 +326,6 @@ class MGDoFObjectAccessor<1, dim> :  public MGDoFAccessor<dim>,
 };
 
 
-
-
-
-
 /**
  * Grant access to the multilevel degrees of freedom located on quads.
  *
@@ -455,8 +451,6 @@ class MGDoFObjectAccessor<2, dim> :  public MGDoFAccessor<dim>,
 };
 
 
-
-
 /**
  * Grant access to the multilevel degrees of freedom located on hexhedra.
  *
@@ -588,7 +582,6 @@ class MGDoFObjectAccessor<3, dim> :  public MGDoFAccessor<dim>,
 };
 
 
-
 /**
  * Grant access to the degrees of freedom on a cell. In fact, since all
  * access to the degrees of freedom has been enabled by the classes
@@ -662,12 +655,4 @@ class MGDoFCellAccessor :  public MGDoFObjectAccessor<dim, dim> {
 };
 
 
-
-
-
-
-
-/*----------------------------   mg_dof_accessor.h     ---------------------------*/
-/* end of #ifndef __mg_dof_accessor_H */
 #endif
-/*----------------------------   mg_dof_accessor.h     ---------------------------*/
index 48c55b0b80da06a7d06a1544efbfb5259c648e38..287d9322c16cd500f913133e7f5e0fabbb7f3594 100644 (file)
@@ -1,15 +1,25 @@
-/*----------------------------   mg_dof.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __mg_dof_H
-#define __mg_dof_H
+//----------------------------  mg_dof_handler.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__mg_dof_handler_h
+#define __deal2__mg_dof_handler_h
+
+
 /*----------------------------   mg_dof.h     ---------------------------*/
 
 
 #include <dofs/dof_handler.h>
 
 
-
 /**
  * Define some types which differ between the dimensions. This class
  * is analogous to the \Ref{TriaDimensionInfo} class hierarchy.
@@ -21,9 +31,6 @@ template <int dim>
 class MGDoFDimensionInfo;
 
 
-
-
-
 /**
  * Define some types for the DoF handling in one dimension.
  *
@@ -53,10 +60,6 @@ class MGDoFDimensionInfo<1> {
 };
 
 
-
-
-
-
 /**
  * Define some types for the DoF handling in two dimensions.
  *
@@ -86,8 +89,6 @@ class MGDoFDimensionInfo<2> {
 };
 
 
-
-
 /**
  * Define some types for the DoF handling in two dimensions.
  *
@@ -117,8 +118,6 @@ class MGDoFDimensionInfo<3> {
 };
 
 
-
-
 /**
  * This class manages degrees of freedom for a multilevel hierarchy of
  * grids. It does mostly the same as does the #DoDHandler# class, but
@@ -450,8 +449,8 @@ class MGDoFHandler : public DoFHandler<dim>
     active_face_iterator last_active_face (const unsigned int level) const;
                                     //@}
 
-    
-                                    /*---------------------------------------*/
+
+/*---------------------------------------*/
 
                                     /**
                                      *  @name Line iterator functions
@@ -510,7 +509,7 @@ class MGDoFHandler : public DoFHandler<dim>
     active_line_iterator end_active_line (const unsigned int level) const;
 
 
-                                    /**
+/**
                                      *  Return an iterator pointing to the
                                      *  last line, used or not.
                                      */
@@ -607,7 +606,7 @@ class MGDoFHandler : public DoFHandler<dim>
     active_quad_iterator end_active_quad (const unsigned int level) const;
 
 
-                                    /**
+/**
                                      *  Return an iterator pointing to the
                                      *  last quad, used or not.
                                      */
@@ -704,7 +703,7 @@ class MGDoFHandler : public DoFHandler<dim>
     active_hex_iterator end_active_hex (const unsigned int level) const;
 
 
-                                    /**
+/**
                                      *  Return an iterator pointing to the
                                      *  last hex, used or not.
                                      */
@@ -896,7 +895,7 @@ class MGDoFHandler : public DoFHandler<dim>
     };
 
 
-                                    /**
+/**
                                      * Distribute dofs on the given cell,
                                      * with new dofs starting with index
                                      * #next_free_dof#. Return the next
@@ -962,11 +961,6 @@ class MGDoFHandler : public DoFHandler<dim>
 #endif
 };
 
-    
-
-
-
-
 
 /* ----------------------- Inline functions of MGVertexDoFs -------------------*/
 
@@ -986,8 +980,6 @@ void MGDoFHandler<dim>::MGVertexDoFs::set_index  (const unsigned int level,
 };
 
 
-
-
 template <int dim>
 inline
 unsigned int
@@ -1003,8 +995,7 @@ MGDoFHandler<dim>::MGVertexDoFs::get_index  (const unsigned int level,
 };
 
 
-
 /*----------------------------   mg_dof.h     ---------------------------*/
-/* end of #ifndef __mg_dof_H */
+
 #endif
 /*----------------------------   mg_dof.h     ---------------------------*/
index 8926c91bb980c3e844370126fb2d30aef955a019..5c23a77418ed3ccee360137661b221839118416a 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   mg_dof_tools.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __mg_dof_tools_H
-#define __mg_dof_tools_H
-/*----------------------------   mg_dof_tools.h     ---------------------------*/
+//----------------------------  mg_dof_tools.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__mg_dof_tools_h
+#define __deal2__mg_dof_tools_h
 
 
 #include <lac/forward_declarations.h>
@@ -62,8 +71,4 @@ class MGDoFTools
 };
 
 
-
-/*----------------------------   mg_dof_tools.h     ---------------------------*/
-/* end of #ifndef __mg_dof_tools_H */
 #endif
-/*----------------------------   mg_dof_tools.h     ---------------------------*/
index 49e36881035d636c4d5c61bf9fd0214a98c5a322..aff3374722e0dde65f069c076ff60b5f37aadf2a 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   mg_smoother.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __mg_smoother_H
-#define __mg_smoother_H
-/*----------------------------   mg_smoother.h     ---------------------------*/
+//----------------------------  mg_smoother.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__mg_smoother_h
+#define __deal2__mg_smoother_h
 
 
 #include <lac/forward_declarations.h>
@@ -12,7 +21,6 @@
 #include <vector>
 
 
-
 /**
  * Abstract base class for multigrid smoothers.
  * In fact, this class only provides the interface of the smoothing function.
@@ -54,9 +62,6 @@ class MGSmootherBase :  public Subscriptor
 };
 
 
-
-
-
 /**
  * Smoother doing nothing. This class is not useful for many applications other
  * than for testing some multigrid procedures. Also some applications might
@@ -84,7 +89,6 @@ class MGSmootherIdentity : public MGSmootherBase
 };
 
 
-
 /**
  * Base class for multigrid smoothers. It declares the interface
  * to smoothers by inheriting #MGSmootherBase# and implements some functionality for setting
@@ -185,8 +189,6 @@ class MGSmoother : public MGSmootherBase
 };
 
 
-
-
 /**
  * Implementation of a smoother using matrix builtin relaxation methods.
  * 
@@ -264,7 +266,6 @@ class MGSmootherRelaxation : public MGSmoother
 };
 
 
-
 /* ------------------------------- Inline functions -------------------------- */
 
 inline
@@ -281,8 +282,6 @@ MGSmoother::get_steps() const
   return steps;
 }
 
-/*----------------------------   mg_smoother.h     ---------------------------*/
-/* end of #ifndef __mg_smoother_H */
+
 #endif
-/*----------------------------   mg_smoother.h     ---------------------------*/
                         
index 4854e02f622f8f4db0dbdfaf6799af6662b2f87c..cc98583b82c2e14bce010a58eb7be2aba89f47d0 100644 (file)
@@ -16,7 +16,6 @@ MGSmootherRelaxation<number>::MGSmootherRelaxation (const MGDoFHandler<dim>
 {};
 
 
-
 template<typename number>
 void
 MGSmootherRelaxation<number>::smooth (const unsigned int   level,
index 602e11bafa02593aac9abbb56df86df59eab1525..cd98244072345059a0c609017c84f8b9c2033c2c 100644 (file)
@@ -1,8 +1,18 @@
-/*----------------------------   multigrid.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __multigrid_H
-#define __multigrid_H
-/*----------------------------   multigrid.h     ---------------------------*/
+//----------------------------  multigrid.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__multigrid_h
+#define __deal2__multigrid_h
+
 
 #include <base/subscriptor.h>
 #include <base/smartpointer.h>
@@ -15,7 +25,6 @@
 #include <vector>
 
 
-
 /**
  * Implementation of multigrid with matrices.
  * While #MGBase# was only an abstract framework for the V-cycle,
@@ -108,7 +117,7 @@ class Multigrid : public MGBase
     SmartPointer<const MGDoFHandler<dim> > mg_dof_handler;
 
 
-                                    /**
+/**
                                      * Sparsity patterns for each level.
                                      */
     SmartPointer<const MGLevelObject<SparsityPattern> > level_sparsities;
@@ -130,9 +139,6 @@ class Multigrid : public MGBase
 };
 
 
-
-
-
 /**
  * Implementation of the #MGTransferBase# interface for which the transfer
  * operations are prebuilt upon construction of the object of this class as
@@ -219,8 +225,6 @@ class MGTransferPrebuilt : public MGTransferBase
 };
 
 
-
-
 /* --------------------------- inline functions --------------------- */
 
 
@@ -236,7 +240,4 @@ Multigrid<dim>::get_matrix (const unsigned int level) const
 }
 
 
-/*----------------------------   multigrid.h     ---------------------------*/
-/* end of #ifndef __multigrid_H */
 #endif
-/*----------------------------   multigrid.h     ---------------------------*/
index 412a84092417756fc7fffba84264775c2228c5b5..f93caa8f465ce6e0c6aea137ba313fb52b64f4f8 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   multigrid.templates.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __multigrid_templates_H
-#define __multigrid_templates_H
-/*----------------------------   multigrid.templates.h     ---------------------------*/
+//----------------------------  multigrid.templates.h  ---------------------------
+//    $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.templates.h  ---------------------------
+#ifndef __deal2__multigrid_templates_h
+#define __deal2__multigrid_templates_h
 
 
 #include <dofs/dof_constraints.h>
@@ -156,9 +165,4 @@ Multigrid<dim>::copy_from_mg(Vector<number> &dst) const
 }
 
 
-
-
-/*----------------------------   multigrid.templates.h     ---------------------------*/
-/* end of #ifndef __multigrid.templates_H */
 #endif
-/*----------------------------   multigrid.templates.h     ---------------------------*/
index 0386f7ff9342867275a37f4f5943332cd5ac4f03..03c28129e441a5f2c351553ed34023ba698045c8 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   problem_assembler.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __problem_assembler_H
-#define __problem_assembler_H
+//----------------------------  assembler.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__assembler_h
+#define __deal2__assembler_h
+
+
 /*----------------------------   problem_assembler.h     ---------------------------*/
 
 #include <base/exceptions.h>
@@ -12,9 +23,6 @@
 #include <vector>
 
 
-
-
-
 /**
  * This is the base class for equation objects. Equations objects describe the
  * finite element discretisation of one or more equations.
@@ -121,9 +129,6 @@ class Equation {
 };
 
 
-
-
-
 /**
  * An #Assembler# is a specialized version of a #DoFCellAccessor# which adds
  * functionality to assemble global matrices and vectors from cell base ones.
@@ -200,10 +205,9 @@ class Assembler : public DoFCellAccessor<dim> {
                                          */
        const UpdateFlags       update_flags;
     };
-    
 
-    
-                                    /**
+
+/**
                                      * Declare the data type that this accessor
                                      * class expects to get passed from the
                                      * iterator classes.
@@ -295,11 +299,8 @@ class Assembler : public DoFCellAccessor<dim> {
     FEValues<dim>     fe_values;
 };
 
-    
-    
-
 
 /*----------------------------   problem_assembler.h     ---------------------------*/
-/* end of #ifndef __problem_assembler_H */
+
 #endif
 /*----------------------------   problem_assembler.h     ---------------------------*/
index a153b14737427cd3147da733685eec2857bf26be..d5f1d0238038ac418dbcbb975e3401a4744fe07c 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   problem_base.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __problem_base_H
-#define __problem_base_H
+//----------------------------  base.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__base_h
+#define __deal2__base_h
+
+
 /*----------------------------   problem_base.h     ---------------------------*/
 
 
@@ -14,8 +25,6 @@
 #include <string>
 
 
-
-
 /**
  * Base class for user problems. This class stores the system matrix and right
  * hand side vectors as well as a solution vector. It initiates the assemblage
@@ -177,7 +186,7 @@ class ProblemBase {
     virtual void fill_data (DataOut<dim> &) const;
 
 
-                                    /**
+/**
                                      * Return the name of the solution as a
                                      * #string#. The default implementation
                                      * returns #"solution"#.
@@ -236,10 +245,8 @@ class ProblemBase {
     friend class Assembler<dim>;
 };
 
-    
-
 
 /*----------------------------   problem_base.h     ---------------------------*/
-/* end of #ifndef __problem_base_H */
+
 #endif
 /*----------------------------   problem_base.h     ---------------------------*/
index 426b562e44737b3c7549a710f7b5315147a1bf3d..4ddbbc247afc86726e023a12d2c46444b9b367d6 100644 (file)
@@ -1,9 +1,18 @@
-/*----------------------------   data_io.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __data_io_H
-#define __data_io_H
-/*----------------------------   data_io.h     ---------------------------*/
+//----------------------------  data_io.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__data_io_h
+#define __deal2__data_io_h
+
 
 #include <base/exceptions.h>
 #include <grid/forward_declarations.h>
@@ -12,8 +21,6 @@
 #include <string>
 
 
-
-
 /**
  * This class is deprecated. Use the #DataOut# class instead.
  *
@@ -476,7 +483,7 @@ class DataOut_Old {
     vector<DataEntry>  cell_data;
 
 
-                                    /**
+/**
                                      * Return the number of faces in the
                                      * triangulation which have a boundary
                                      * indicator not equal to zero. Only
@@ -592,8 +599,6 @@ class DataOut_Old {
 };
 
 
-
-
 /**
  * Structure for the control of encapsulated postscript output. See
  * general documentation of class #DataOut_Old# for description.
@@ -715,8 +720,5 @@ class EpsOutputData{
 };
 
 
-/*----------------------------   data_io.h     ---------------------------*/
-/* end of #ifndef __data_io_H */
 #endif
-/*----------------------------   data_io.h     ---------------------------*/
 
index 0fbe8386aa9b94a9e1f2b4f594ce80e74731879a..237c187f06dbf8417c7e71fb05403421cf39f51d 100644 (file)
@@ -1,15 +1,24 @@
-/*----------------------------   data_out.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __data_out_H
-#define __data_out_H
-/*----------------------------   data_out.h     ---------------------------*/
+//----------------------------  data_out.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__data_out_h
+#define __deal2__data_out_h
+
 
 #include <lac/forward_declarations.h>
 #include <grid/forward_declarations.h>
 #include <base/data_out_base.h>
 
 
-
 /**
  * This is an abstract class which provides the functionality to generate
  * patches for output by base classes from data vectors on a grid. It alloes
@@ -312,8 +321,6 @@ class DataOut_DoFData : public DataOutInterface<dim>
 };
 
 
-
-
 /**
  * This class is an actual implementation of the functionality proposed by
  * the #DataOut_DoFData# class. It offers a function #build_patches# that
@@ -388,9 +395,9 @@ class DataOut : public DataOut_DoFData<dim>
                                      */
     virtual void build_patches (const unsigned int n_subdivisions = 1,
                                const unsigned int n_threads_     = 1);
-    
 
-                                    /**
+
+/**
                                      * Return the first cell which we
                                      * want output for. The default
                                      * implementation returns the first
@@ -457,10 +464,4 @@ class DataOut : public DataOut_DoFData<dim>
 };
 
 
-
-
-
-/*----------------------------   data_out.h     ---------------------------*/
-/* end of #ifndef __data_out_H */
 #endif
-/*----------------------------   data_out.h     ---------------------------*/
index 5e7c3b20c942cb18eae99ff620dc014a3dd29e27..af0bfbb5c56e94d44f6d894b77938667c32ec335 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   data_out_stack.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __data_out_stack_H
-#define __data_out_stack_H
-/*----------------------------   data_out_stack.h     ---------------------------*/
+//----------------------------  data_out_stack.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__data_out_stack_h
+#define __deal2__data_out_stack_h
 
 
 #include <base/data_out_base.h>
@@ -14,7 +23,6 @@
 #include <vector>
 
 
-
 /**
  * This class is used to stack the output from several computations
  * into one output file by stacking the data sets in another
@@ -168,9 +176,9 @@ class DataOutStack : public DataOutInterface<dim+1>
                                      */
     void declare_data_vector (const vector<string> &name,
                              const VectorType      vector_type);
-    
 
-                                    /**
+
+/**
                                      * Add a data vector for the presently
                                      * set value of the parameter.
                                      *
@@ -383,7 +391,7 @@ class DataOutStack : public DataOutInterface<dim+1>
     virtual const vector<DataOutBase::Patch<dim+1> > & get_patches () const;
 
 
-                                    /**
+/**
                                      * Virtual function through
                                      * which the names of data sets are
                                      * obtained by the output functions
@@ -393,8 +401,4 @@ class DataOutStack : public DataOutInterface<dim+1>
 };
 
 
-
-/*----------------------------   data_out_stack.h     ---------------------------*/
-/* end of #ifndef __data_out_stack_H */
 #endif
-/*----------------------------   data_out_stack.h     ---------------------------*/
index 9c4923f6d5138cec1b4ccf709f823015289df78f..af0809ae9579e9a2e9fcb8ce133c732ee0ccf036 100644 (file)
@@ -1,16 +1,23 @@
-/*----------------------------   dof_renumbering.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __dof_renumbering_H
-#define __dof_renumbering_H
-/*----------------------------   dof_renumbering.h     ---------------------------*/
+//----------------------------  dof_renumbering.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__dof_renumbering_h
+#define __deal2__dof_renumbering_h
 
 
 #include <base/exceptions.h>
 #include <grid/forward_declarations.h>
 
 
-
-
 /**
  * Implementation of a number of renumbering algorithms for the degrees of
  * freedom on a triangulation.
@@ -238,8 +245,8 @@ class DoFRenumbering
     static void component_wise (DoFHandler<dim>            &dof_handler,
                                const vector<unsigned int> &component_order = vector<unsigned int>());
 
-    
-                                    /**
+
+/**
                                      * Exception
                                      */
     DeclException0 (ExcRenumberingIncomplete);
@@ -250,13 +257,4 @@ class DoFRenumbering
 };
 
 
-
-
-
-
-
-
-/*----------------------------   dof_renumbering.h     ---------------------------*/
-/* end of #ifndef __dof_renumbering_H */
 #endif
-/*----------------------------   dof_renumbering.h     ---------------------------*/
index 92d766f3e76ffb49729f5016ac4e9726c90dca76..f2ab12e961f9980222b00622e9d4c2cf24861d81 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   error_estimator.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __error_estimator_H
-#define __error_estimator_H
-/*----------------------------   error_estimator.h     ---------------------------*/
+//----------------------------  error_estimator.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__error_estimator_h
+#define __deal2__error_estimator_h
 
 
 #include <base/exceptions.h>
@@ -199,8 +207,8 @@ class KellyErrorEstimator
                                      */    
     typedef map<unsigned char,const Function<dim>*> FunctionMap;
 
-    
-                                    /**
+
+/**
                                      * Implementation of the error
                                      * estimator described above. You
                                      * may give a coefficient, but
@@ -273,13 +281,12 @@ class KellyErrorEstimator
                                      * Exception
                                      */
     DeclException0 (ExcInvalidBoundaryFunction);
-    
 
 
-  private:
+private:
 
 
-                                    /**
+/**
                                      * Declare a data type to represent the
                                      * mapping between faces and integrated
                                      * jumps of gradients. See the general
@@ -288,14 +295,14 @@ class KellyErrorEstimator
     typedef map<typename DoFHandler<dim>::face_iterator,double> FaceIntegrals;
 
 
-                                    /**
+/**
                                      * Redeclare an active cell iterator.
                                      * This is simply for convenience.
                                      */
     typedef DoFHandler<dim>::active_cell_iterator active_cell_iterator;
 
 
-                                    /**
+/**
                                      * All data needed by the several functions
                                      * of the error estimator is gathered in
                                      * this struct. It is passed as a reference
@@ -414,8 +421,8 @@ class KellyErrorEstimator
             unsigned int             n_threads);
     };
 
-    
-                                    /**
+
+/**
                                      * Computates the error on all cells
                                      * of the domain with the number n,
                                      * satisfying
@@ -453,15 +460,15 @@ class KellyErrorEstimator
                                      */
 
 
-    static void integrate_over_regular_face (Data                       &data,
+static void integrate_over_regular_face (Data                       &data,
                                             const unsigned int          this_thread,
                                             const active_cell_iterator &cell,
                                             const unsigned int          face_no,
                                             FEFaceValues<dim>          &fe_face_values_cell,
                                             FEFaceValues<dim>          &fe_face_values_neighbor);
-    
-    
-                                    /**
+
+
+/**
                                      * The same applies as for the function
                                      * above, except that integration is
                                      * over face #face_no# of #cell#, where
@@ -478,12 +485,6 @@ class KellyErrorEstimator
 };
 
 
-
-
-
-/*----------------------------   error_estimator.h     ---------------------------*/
-/* end of #ifndef __error_estimator_H */
 #endif
-/*----------------------------   error_estimator.h     ---------------------------*/
 
 
index 8bdacaaf41f4f3673fc4c6c1826d30279c0d3648..e0c78a5dff85913c23a7d5633094fc8268650af1 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   histogram.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __histogram_H
-#define __histogram_H
-/*----------------------------   histogram.h     ---------------------------*/
+//----------------------------  histogram.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__histogram_h
+#define __deal2__histogram_h
 
 
 #include <base/exceptions.h>
@@ -11,7 +20,6 @@
 #include <string>
 
 
-
 /**
  * This class provides some facilities to generate 2d and 3d histograms.
  * It is used by giving it one or several data sets and a rule how to
@@ -62,9 +70,9 @@ class Histogram
     enum IntervalSpacing {
          linear, logarithmic
     };
-    
 
-                                    /**
+
+/**
                                      * Take several lists of values, each on
                                      * to produce one histogram that will
                                      * then be arrange one behind each other.
@@ -241,9 +249,4 @@ class Histogram
 };
 
 
-
-
-/*----------------------------   histogram.h     ---------------------------*/
-/* end of #ifndef __histogram_H */
 #endif
-/*----------------------------   histogram.h     ---------------------------*/
index 3e15f0914c55f373c9103dbce385d570a6ac4eea..37c761551aa86562040e72f08e9e3d698151c69e 100644 (file)
@@ -1,18 +1,23 @@
-/*----------------------------   matrices.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __matrices_H
-#define __matrices_H
-/*----------------------------   matrices.h     ---------------------------*/
-
+//----------------------------  matrices.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__matrices_h
+#define __deal2__matrices_h
 
 
 #include <base/exceptions.h>
 #include <map>
 
 
-
-
 /**
  * Provide a class which assembles certain standard matrices for a given
  * triangulation, using a given finite element and a quadrature formula.
@@ -339,9 +344,6 @@ class MatrixCreator
 };
 
 
-
-
-
 /**
  * Provide a collection of functions operating on matrices. These include
  * the application of boundary conditions to a linear system of equations
@@ -435,8 +437,6 @@ class MatrixTools : public MatrixCreator<dim>
 };
 
 
-
-
 /**
  * Equation class to be passed to the #Assembler# if you want to make up the
  * mass matrix for your problem. The mass matrix is the matrix with
@@ -589,9 +589,6 @@ class MassMatrix :  public Equation<dim> {
 };
 
 
-
-
-
 /**
  * Equation class to be passed to the #Assembler# if you want to make up the
  * laplace matrix for your problem. The laplace matrix is the matrix with
@@ -692,13 +689,4 @@ class LaplaceMatrix :  public Equation<dim> {
 };
 
 
-
-
-
-
-
-
-/*----------------------------   matrices.h     ---------------------------*/
-/* end of #ifndef __matrices_H */
 #endif
-/*----------------------------   matrices.h     ---------------------------*/
index 90dc38aadaeef709dd8c4b00b00bc846a18fb262..f8d155c014d30513bd43a464c2ce078ee55d2903 100644 (file)
@@ -1,8 +1,19 @@
-/*----------------------------   solutiontransfer.h     ----------------------*/
-/*      $Id$      */
-/*           Ralf Hartmann, University of Heidelberg                          */
-#ifndef __solutiontransfer_H
-#define __solutiontransfer_H
+//----------------------------  solution_transfer.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__solution_transfer_h
+#define __deal2__solution_transfer_h
+
+
 /*----------------------------   solutiontransfer.h     ----------------------*/
 
 
@@ -13,8 +24,6 @@
 #include <vector>
 
 
-
-
 /**
  * Transfers a discrete FE function (like a solution vector) by interpolation
  * while refining and/or coarsening a grid. During interpolation the
@@ -341,7 +350,7 @@ class SolutionTransfer
     PreparationState prepared_for;
 
 
-                                    /**
+/**
                                      * Is used for #prepare_for_refining#
                                      * (of course also for
                                      * #repare_for_refining_and_coarsening#)
@@ -396,11 +405,7 @@ class SolutionTransfer
 };
 
 
-
-
-
-
 /*----------------------------   solutiontransfer.h     ---------------------------*/
-/* end of #ifndef __solutiontransfer_H */
+
 #endif
 /*----------------------------   solutiontransfer.h     ---------------------------*/
index 3e73d679153bc109de3a3edfb7400896e0112b5a..a2f700ea5580f0f6b5e775a328ece3fb75669700 100644 (file)
@@ -1,7 +1,19 @@
-/*----------------------------   time-dependent.h     ---------------------------*/
-/*      $Id$                 */
-#ifndef __time_dependent_H
-#define __time_dependent_H
+//----------------------------  time_dependent.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__time_dependent_h
+#define __deal2__time_dependent_h
+
+
 /*----------------------------   time-dependent.h     ---------------------------*/
 
 
@@ -14,8 +26,6 @@
 #include <utility>
 
 
-
-
 /**
  * This class provides an abstract interface to time dependent problems in that
  * it addresses some of the most annoying aspects of this class of problems:
@@ -422,9 +432,9 @@ class TimeDependent
     TimeDependent (const TimeSteppingData &data_primal,
                   const TimeSteppingData &data_dual,
                   const TimeSteppingData &data_postprocess);
-    
-    
-                                    /**
+
+
+/**
                                      * Destructor. This will delete the
                                      * objects pointed to by the pointers
                                      * given to the #insert_*# and
@@ -592,9 +602,9 @@ class TimeDependent
                  LoopFunctionObject      loop_function,
                  const TimeSteppingData &timestepping_data,
                  const Direction         direction);
-    
-                 
-                                    /**
+
+
+/**
                                      * Initialize the objects for the next
                                      * sweep. This function specifically does
                                      * the following: assign each time
@@ -718,11 +728,6 @@ class TimeDependent
 };
 
 
-
-
-
-
-
 /**
  * Base class for a time step in time dependent problems. This class provides
  * barely more than the basic framework, defining the necessary virtual
@@ -1065,9 +1070,9 @@ class TimeStepBase : public Subscriptor
                                      * sweep.
                                      */
     void set_sweep_no (const unsigned int sweep_no);
-    
 
-                                    /**
+
+/**
                                      * Copy constructor. I can see no reason
                                      * why someone might want to use it, so
                                      * I don't provide it. Since this class
@@ -1093,10 +1098,6 @@ class TimeStepBase : public Subscriptor
     friend class TimeDependent;
 };
 
-       
-
-
-
 
 /**
  * Specialisation of #TimeStepBase# which addresses some aspects of grid handling.
@@ -1132,10 +1133,9 @@ class TimeStepBase_Tria :  public TimeStepBase
     enum SolutionState {
          grid_refinement = 0x1000
     };
-    
-    
-    
-                                    /**
+
+
+/**
                                      * Default constructor. Does nothing but
                                      * throws an exception. We need to have
                                      * such a constructor in order to satisfy
@@ -1378,8 +1378,6 @@ class TimeStepBase_Tria :  public TimeStepBase
 };
 
 
-
-
 /**
  * This structure is used to tell the #TimeStepBase_Tria# class how grids should
  * be handled. It has flags defining the moments where grids shall be
@@ -1455,8 +1453,6 @@ struct TimeStepBase_Tria<dim>::Flags
 };
 
 
-
-
 /**
  * This structure is used to tell the #TimeStepBase_Tria# class how grids should
  * be refined. Before we explain all the different variables, fist some terminology:
@@ -1634,7 +1630,7 @@ struct TimeStepBase_Tria<dim>::RefinementFlags
     const unsigned int  first_sweep_with_correction;
 
 
-                                    /**
+/**
                                      * Apply cell number correction with the
                                      * previous time level only if there are
                                      * more than this number of cells.
@@ -1710,8 +1706,6 @@ struct TimeStepBase_Tria<dim>::RefinementFlags
 };
 
 
-
-
 /**
  * Structure given to the actual refinement function, telling it which
  * thresholds to take for coarsening and refinement. The actual refinement
@@ -1754,8 +1748,6 @@ struct TimeStepBase_Tria<dim>::RefinementData
 };
 
 
-
-
 /*----------------------------- template functions ------------------------------*/
 
 template <typename InitFunctionObject, typename LoopFunctionObject>
@@ -1791,9 +1783,9 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
                             (timesteps[n_timesteps-step-1]));
              break;
       };
-  
 
-                                  // wake up the first few time levels
+
+// wake up the first few time levels
   for (int step=-timestepping_data.look_ahead; step<0; ++step)
     for (int look_ahead=0;
         look_ahead<=static_cast<int>(timestepping_data.look_ahead); ++look_ahead)
@@ -1808,9 +1800,9 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
                  timesteps[n_timesteps-(step+look_ahead)]->wake_up(look_ahead);
                break;
        };
-  
-  
-  for (unsigned int step=0; step<n_timesteps; ++step)
+
+
+for (unsigned int step=0; step<n_timesteps; ++step)
     {
                                       // first thing: wake up the
                                       // timesteps ahead as necessary
@@ -1827,9 +1819,9 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
                    timesteps[n_timesteps-(step+look_ahead)-1]->wake_up(look_ahead);
                  break;
          };
-      
-      
-                                      // actually do the work
+
+
+// actually do the work
       switch (direction)
        {
          case forward:
@@ -1881,9 +1873,7 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
 };
 
 
-
-
 /*----------------------------   time-dependent.h     ---------------------------*/
-/* end of #ifndef __time_dependent_H */
+
 #endif
 /*----------------------------   time-dependent.h     ---------------------------*/
index be4b48289655cd32b33ad08b9e0c659c60b2b62c..762234c0db456e141ed1511b66654bcaecbcd6c4 100644 (file)
@@ -1,9 +1,17 @@
-/*----------------------------   vectors.h     ---------------------------*/
-/*      $Id$                 */
-/*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __vectors_H
-#define __vectors_H
-/*----------------------------   vectors.h     ---------------------------*/
+//----------------------------  vectors.h  ---------------------------
+//    $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.h  ---------------------------
+#ifndef __deal2__vectors_h
+#define __deal2__vectors_h
 
 
 #include <base/forward_declarations.h>
@@ -35,8 +43,6 @@ enum NormType {
 };
 
 
-
-
 /**
  * Provide a class which offers some operations on vectors. Amoung these are
  * assemblage of standard vectors, integration of the difference of a
@@ -503,9 +509,9 @@ class VectorTools
                                      */
     static void subtract_mean_value(Vector<double>     &v,
                                    const vector<bool> &p_select);
-    
 
-                                    /**
+
+/**
                                      * Exception
                                      */
     DeclException0 (ExcNotUseful);
@@ -524,8 +530,4 @@ class VectorTools
 };
 
 
-
-/*----------------------------   vectors.h     ---------------------------*/
-/* end of #ifndef __vectors_H */
 #endif
-/*----------------------------   vectors.h     ---------------------------*/

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.