]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix length of separators
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 25 May 2018 08:31:22 +0000 (10:31 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 25 May 2018 14:57:51 +0000 (16:57 +0200)
66 files changed:
include/deal.II/base/bounding_box.h
include/deal.II/base/function_time.h
include/deal.II/base/job_identifier.h
include/deal.II/base/partitioner.h
include/deal.II/base/point.h
include/deal.II/base/process_grid.h
include/deal.II/base/smartpointer.h
include/deal.II/base/thread_local_storage.h
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/differentiation/ad/adolc_number_types.h
include/deal.II/differentiation/ad/adolc_product_types.h
include/deal.II/differentiation/ad/sacado_number_types.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_handler_policy.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/fe_values_extractors.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/cuda_vector.h
include/deal.II/lac/filtered_matrix.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_vector.h
include/deal.II/lac/petsc_full_matrix.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_matrix_free.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_sparse_matrix.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/scalapack.h
include/deal.II/lac/sparse_ilu.templates.h
include/deal.II/lac/swappable_vector.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_data_on_the_fly.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/time_dependent.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/opencascade/boundary_lib.h
include/deal.II/opencascade/utilities.h
include/deal.II/particles/particle.h
include/deal.II/particles/particle_handler.h
source/distributed/tria.cc
source/dofs/dof_accessor.cc
source/fe/fe_values.cc
source/fe/mapping.cc
source/grid/tria_accessor.cc
source/numerics/data_postprocessor.cc
source/numerics/derivative_approximation.cc
tests/dofs/sparsity_pattern.cc
tests/dofs/sparsity_pattern_01.cc
tests/tests.h

index c2580cb3cfb911380d67fbe9fd8569affeb97eb6..ec1e66674cd1ae01424fe2078f8ae311e1e8602b 100644 (file)
@@ -157,8 +157,7 @@ private:
   std::pair<Point<spacedim, Number>, Point<spacedim, Number>> boundary_points;
 };
 
-/*------------------------------- Inline functions: BoundingBox
- * ---------------------------*/
+/*------------------------ Inline functions: BoundingBox --------------------*/
 
 #ifndef DOXYGEN
 
@@ -170,10 +169,9 @@ inline BoundingBox<spacedim, Number>::BoundingBox(
 {
   // We check the Bounding Box is not degenerate
   for (unsigned int i = 0; i < spacedim; ++i)
-    Assert(
-      boundary_points.first[i] <= boundary_points.second[i],
-      ExcMessage(
-        "Bounding Box can't be created: the point's order should be bottom left, top right!"));
+    Assert(boundary_points.first[i] <= boundary_points.second[i],
+           ExcMessage("Bounding Box can't be created: the point's "
+                      "order should be bottom left, top right!"));
 
   this->boundary_points = boundary_points;
 }
index 4e98e5185e5bb981cab5e614192acd77fc1be178..caee6f3fd3d8353c3830ca4fbed55d370a154ec3 100644 (file)
@@ -111,8 +111,7 @@ private:
 
 
 
-/*------------------------------ Inline functions
- * ------------------------------*/
+/*----------------------------- Inline functions ----------------------------*/
 
 #ifndef DOXYGEN
 
index 48788472bc3c74bf1b2c0cba76768eda98f0100c..719beb4bdae4f8602a383ebd204e87de487a1da3 100644 (file)
@@ -74,8 +74,7 @@ private:
 };
 
 
-/*------------------------------ Inline functions
- * ------------------------------*/
+/*----------------------------- Inline functions ----------------------------*/
 
 
 /**
index e4c19682e8e00b694089168ae0a63a65ef36a64b..6fc793e732fc85e7633c2659550c77c5e2e7d66c 100644 (file)
@@ -673,8 +673,7 @@ namespace Utilities
 
 
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*--------------------- Inline functions --------------------------------*/
 
 #ifndef DOXYGEN
 
index 172d9469cb16ce212e2334ce8a2613c56d9f0f64..592ad860790ef510f171191fa08f00782bda326e 100644 (file)
@@ -274,8 +274,7 @@ public:
   serialize(Archive &ar, const unsigned int version);
 };
 
-/*------------------------------- Inline functions: Point
- * ---------------------------*/
+/*--------------------------- Inline functions: Point -----------------------*/
 
 #ifndef DOXYGEN
 
@@ -522,8 +521,7 @@ Point<dim, Number>::serialize(Archive &ar, const unsigned int)
 #endif // DOXYGEN
 
 
-/*------------------------------- Global functions: Point
- * ---------------------------*/
+/*--------------------------- Global functions: Point -----------------------*/
 
 
 /**
index 91acf6627d62b204249ecd9596191e6802742f11..f8e4065dcb33b8baabde481528568f230501f2ad 100644 (file)
@@ -198,8 +198,7 @@ namespace Utilities
       bool mpi_process_is_active;
     };
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*--------------------- Inline functions --------------------------------*/
 
 #  ifndef DOXYGEN
 
index 7688f5d172bf4a52fbee74456653d6b2825f0fe5..3cb2c48f1787f674503d4bf571c540b33aa184f6 100644 (file)
@@ -201,8 +201,7 @@ private:
 };
 
 
-/* --------------------------- inline Template functions
- * ------------------------------*/
+/* --------------------- inline Template functions ------------------------- */
 
 
 template <typename T, typename P>
index dbf0fd81c72fb788a45b10b7d33cf0d72ee373bb..cfb10604387e6d89312419c073a5321ccf0e2270 100644 (file)
@@ -181,8 +181,7 @@ namespace Threads
 #  endif
   };
 
-  // ----------------- inline and template functions
-  // ----------------------------
+  // ----------------- inline and template functions --------------------------
 
   template <typename T>
   inline ThreadLocalStorage<T>::ThreadLocalStorage(const T &t) : data(t)
index 84845d882741939471f220116dbeb2a08c595871..93f5adf999ec2dee78eccff53308c2af266c2795 100644 (file)
@@ -296,8 +296,7 @@ namespace Differentiation
 } // namespace Differentiation
 
 
-/* --------------------------- inline and template functions and specializations
- * ------------------------- */
+/* ----------- inline and template functions and specializations ----------- */
 
 
 #ifndef DOXYGEN
index 69288a769186a9c13fb1acb1361f1b771057c847..3075ef49eddadfc3b96bea054f46f6b926203a66 100644 (file)
@@ -97,8 +97,7 @@ DeclExceptionMsg(ExcADOLCAdvancedBranching,
                  "numbers when the advanced branching feature is activated.");
 
 
-/* --------------------------- inline and template functions and specializations
- * ------------------------- */
+/* ----------- inline and template functions and specializations ----------- */
 
 
 #  ifndef DOXYGEN
index 02ae380d9781dd9ad606b75912d8b32f5853d685..026580fecfb3b0d5a68eb58615fdfaa910a4b113 100644 (file)
@@ -28,8 +28,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-/* -------------- Adol-C taped (Differentiation::AD::NumberTypes::adolc_taped)
- * -------------- */
+/* ------ Adol-C taped (Differentiation::AD::NumberTypes::adolc_taped) ----- */
 
 
 namespace internal
@@ -183,8 +182,7 @@ struct EnableIfScalar<std::complex<adub>>
 };
 
 
-/* -------------- Adol-C tapeless
- * (Differentiation::AD::NumberTypes::adolc_tapeless) -------------- */
+/* -- Adol-C tapeless (Differentiation::AD::NumberTypes::adolc_tapeless) -- */
 
 
 namespace internal
index 8d16de3312e05b041144295e7ec405318a1ae136..de863f7773e4c21581c670ccfbfbb1a60b0e45cf 100644 (file)
@@ -121,8 +121,7 @@ namespace Differentiation
 } // namespace Differentiation
 
 
-/* --------------------------- inline and template functions and specializations
- * ------------------------- */
+/* ----------- inline and template functions and specializations ----------- */
 
 
 #  ifndef DOXYGEN
index d66450e65e541a5ea8c90038f38a3673b92eae9e..5267254b031343824a6785abc1e5366187ce592d 100644 (file)
@@ -2253,8 +2253,7 @@ inline typename dealii::internal::DoFHandlerImplementation::
 }
 
 
-/*------------------------- Functions: DoFAccessor<0,1,spacedim>
- * ---------------------------*/
+/*----------------- Functions: DoFAccessor<0,1,spacedim> --------------------*/
 
 
 template <template <int, int> class DoFHandlerType,
index f989d9db376f72d1c13dfc9cc618b663bd4b2850..4ee4cdb0fb182ae20cd045c0a8c053163d129914 100644 (file)
@@ -261,8 +261,5 @@ namespace internal
 
 DEAL_II_NAMESPACE_CLOSE
 
-/*----------------------------   dof_handler_policy.h
- * ---------------------------*/
 #endif
-/*----------------------------   dof_handler_policy.h
- * ---------------------------*/
+/*--------------------------   dof_handler_policy.h -------------------------*/
index 58a20efb057eb8f574404c86a4da28377b46d891..1dd3c2a448a54d3bde7ab2aceeb03c7bbf41e5ec 100644 (file)
@@ -1802,7 +1802,5 @@ namespace FETools
 
 DEAL_II_NAMESPACE_CLOSE
 
-/*----------------------------   fe_tools_extrapolate_templates.h
- * ---------------------------*/
-/* end of #ifndef dealii_fe_tools_extrapolate_templates_H */
-#endif
+/*--------------------   fe_tools_extrapolate_templates.h -------------------*/
+#endif // dealii_fe_tools_extrapolate_templates_H
index c4a1da590ad9a88d24e1efa006d40bb5ca288bf1..a576829a61b79fc0e7f76042da628060249e3ea0 100644 (file)
@@ -715,7 +715,5 @@ namespace FETools
 
 DEAL_II_NAMESPACE_CLOSE
 
-/*----------------------------   fe_tools_interpolate_templates.h
- * ---------------------------*/
-/* end of #ifndef dealii_fe_tools_interpolate_templates_H */
-#endif
+/*---------------------- fe_tools_interpolate_templates.h -------------------*/
+#endif // dealii_fe_tools_interpolate_templates_H
index bcd47e3ef19e1e48af8d0f2a84570a6459971147..302b3b4fc89f01084f59db062c271f567574ed56 100644 (file)
@@ -4764,8 +4764,7 @@ namespace FEValuesViews
 
 
 
-/*------------------------ Inline functions: FEValuesBase
- * ------------------------*/
+/*---------------------- Inline functions: FEValuesBase ---------------------*/
 
 
 
@@ -5422,8 +5421,7 @@ FEValuesBase<dim, spacedim>::normal_vector(const unsigned int i) const
 
 
 
-/*------------------------ Inline functions: FEValues
- * ----------------------------*/
+/*--------------------- Inline functions: FEValues --------------------------*/
 
 
 template <int dim, int spacedim>
@@ -5443,8 +5441,7 @@ FEValues<dim, spacedim>::get_present_fe_values() const
 }
 
 
-/*------------------------ Inline functions: FEFaceValuesBase
- * --------------------*/
+/*---------------------- Inline functions: FEFaceValuesBase -----------------*/
 
 
 template <int dim, int spacedim>
@@ -5455,8 +5452,7 @@ FEFaceValuesBase<dim, spacedim>::get_face_index() const
 }
 
 
-/*------------------------ Inline functions: FE*FaceValues
- * --------------------*/
+/*----------------------- Inline functions: FE*FaceValues -------------------*/
 
 template <int dim, int spacedim>
 inline const Quadrature<dim - 1> &
index 4d66e9237234f5934bae9db7895496dce3e14e7c..67fabbe489eae62fb836ecd7e18993cbcfff4e6b 100644 (file)
@@ -211,8 +211,7 @@ namespace FEValuesExtractors
 } // namespace FEValuesExtractors
 
 
-/*------------------------ Inline functions: namespace FEValuesExtractors
- * --------*/
+/*-------------- Inline functions: namespace FEValuesExtractors -------------*/
 
 namespace FEValuesExtractors
 {
index 7b638cf4857defc9b47266eb7634c91946f11c8c..2f2567aeb72e753a48cb55aa72d6f86eb7498332 100644 (file)
@@ -2798,8 +2798,7 @@ public:
    * @}
    */
 
-  /*---------------------------------------*/
-  /*---------------------------------------*/
+  /*-------------------------------------------------------------------------*/
 
   /**
    * @name Face iterator functions
@@ -2829,8 +2828,7 @@ public:
    * @}
    */
 
-  /*---------------------------------------*/
-  /*---------------------------------------*/
+  /*-------------------------------------------------------------------------*/
 
   /**
    * @name Vertex iterator functions
index 6cc02595c1e166345fbf1bbb1a91b3b96bf1d450..4ae035850a9ef6b4e34729ff2c0bae5a76924390 100644 (file)
@@ -3524,8 +3524,7 @@ private:
 
 
 
-/* -------------- declaration of explicit
-   specializations and general templates ------------- */
+/* ----- declaration of explicit specializations and general templates ----- */
 
 
 template <int structdim, int dim, int spacedim>
index 3c086de72226dde9df34f14223ccd9a617b549b4..5fc31df244730f6519ca0ac9f3ab2da4c12dbd90 100644 (file)
@@ -42,8 +42,7 @@ namespace parallel
 }
 
 
-/*------------------------ Functions: TriaAccessorBase
- * ---------------------------*/
+/*--------------------- Functions: TriaAccessorBase -------------------------*/
 
 template <int structdim, int dim, int spacedim>
 inline TriaAccessorBase<structdim, dim, spacedim>::TriaAccessorBase(
@@ -393,8 +392,7 @@ TriaAccessorBase<structdim, dim, spacedim>::objects() const
 
 
 
-/*------------------------ Functions: InvalidAccessor
- * ---------------------------*/
+/*---------------------- Functions: InvalidAccessor -------------------------*/
 
 template <int structdim, int dim, int spacedim>
 InvalidAccessor<structdim, dim, spacedim>::InvalidAccessor(
@@ -2236,8 +2234,7 @@ TriaAccessor<structdim, dim, spacedim>::is_translation_of(
 }
 
 
-/*------------------------ Functions: TriaAccessor<0,dim,spacedim>
- * -----------------------*/
+/*----------------- Functions: TriaAccessor<0,dim,spacedim> -----------------*/
 
 template <int dim, int spacedim>
 inline TriaAccessor<0, dim, spacedim>::TriaAccessor(
@@ -2595,8 +2592,7 @@ TriaAccessor<0, dim, spacedim>::used() const
 
 
 
-/*------------------------ Functions: TriaAccessor<0,1,spacedim>
- * -----------------------*/
+/*------------------- Functions: TriaAccessor<0,1,spacedim> -----------------*/
 
 template <int spacedim>
 inline TriaAccessor<0, 1, spacedim>::TriaAccessor(
@@ -3022,8 +3018,7 @@ TriaAccessor<0, 1, spacedim>::used() const
   return tria->vertex_used(global_vertex_index);
 }
 
-/*------------------------ Functions: CellAccessor<dim,spacedim>
- * -----------------------*/
+/*------------------ Functions: CellAccessor<dim,spacedim> ------------------*/
 
 
 template <int dim, int spacedim>
index 28abdf5079f6dd24d878198865b92b7090adb702..2d3147afd238a18e52e1595b4a4aa440e5215690 100644 (file)
@@ -758,8 +758,7 @@ namespace TrilinosWrappers
 
 #endif
 
-/*---------------------- Template functions
- * -----------------------------------*/
+/*--------------------- Template functions ----------------------------------*/
 
 
 
index d011afa3e47c828e9cac67c12372db8a4c8a540e..be0b6677d603aa22c1ce141090b42ab14403bade 100644 (file)
@@ -2051,12 +2051,7 @@ ChunkSparseMatrix<number>::end(const unsigned int r)
 
 #  endif // DOXYGEN
 
-
-/*----------------------------   chunk_sparse_matrix.h
- * ---------------------------*/
-
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
-/*----------------------------   chunk_sparse_matrix.h
- * ---------------------------*/
+/*--------------------------- chunk_sparse_matrix.h -------------------------*/
index 505776eece91be8d469e097af412017707eadd52..f27206d6530eb2b0a616b65b7ddde815d9029b05 100644 (file)
@@ -308,8 +308,7 @@ namespace LinearAlgebra
 
 
 
-    // ------------------------------ Inline functions
-    // -----------------------------
+    // ---------------------------- Inline functions --------------------------
     template <typename Number>
     inline Number *
     Vector<Number>::get_values() const
index 8737f4e607f99752966e1fc844fe7582bd469cf5..3f7a00dc821b32f62d7767dc286f73ed5320e102 100644 (file)
@@ -679,8 +679,7 @@ operator!=(const const_iterator &other) const
 
 
 
-//------------------------------- FilteredMatrix
-//---------------------------------------//
+//------------------------- FilteredMatrix ----------------------------------//
 
 template <typename number>
 inline typename FilteredMatrix<number>::const_iterator
index f419ab1a645f75b99fa59825b2fddd5424720714..625fc07e59196a528be6502147dfbe5f354dba31 100644 (file)
@@ -1308,8 +1308,7 @@ namespace LinearAlgebra
     /*@}*/
 
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*-------------------- Inline functions ---------------------------------*/
 
 #ifndef DOXYGEN
 
index 88bbc7a6c17222eb601900e37762ad6d9b06bfc2..c7d26269af80293d15da722762c88a0e321e4e08 100644 (file)
@@ -393,8 +393,7 @@ namespace LinearAlgebra
   };
 
   /*@}*/
-  /*----------------------- Inline functions
-   * ----------------------------------*/
+  /*--------------------------- Inline functions ----------------------------*/
 
   template <typename Number>
   inline Vector<Number>::Vector(const Vector<Number> &V) :
index 905e9177a9536d424fc6bffe7d6f0856137efd56..4bb48e10cd55b3efcd4ba46872d78bf21bc63102 100644 (file)
@@ -102,9 +102,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_full_matrix.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_full_matrix.h
- * ---------------------------*/
+/*---------------------------- petsc_full_matrix.h --------------------------*/
index 31078df133487dccfb5f81ed5b6577bbeeb1fe25..c23fb51d6159a1a675c27d6f32e14095c10f9154 100644 (file)
@@ -1078,8 +1078,7 @@ namespace PETScWrappers
 
 
 #    ifndef DOXYGEN
-  // -------------------------- inline and template functions
-  // ----------------------
+  // ---------------------- inline and template functions ---------------------
 
 
   namespace MatrixIterators
@@ -1607,10 +1606,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-
-/*----------------------------   petsc_matrix_base.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_matrix_base.h
- * ---------------------------*/
+/*---------------------------- petsc_matrix_base.h --------------------------*/
index 8122509a06cdf06b125185125ad144b2fc99356c..8b3df0df094ba81d15b05eba5c0e6d74e9533bec 100644 (file)
@@ -301,10 +301,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-
-/*----------------------------   petsc_matrix_free.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_matrix_free.h
- * ---------------------------*/
+/*---------------------------- petsc_matrix_free.h --------------------------*/
index 26e95f633ed1a4bf4a5329e4e08515155eba4d20..54114738fcf851035d2a2ef3ab8596414536aea4 100644 (file)
@@ -288,8 +288,7 @@ namespace PETScWrappers
 
     /*@}*/
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*--------------------- Inline functions --------------------------------*/
 
     inline BlockVector::BlockVector(const unsigned int n_blocks,
                                     const MPI_Comm &   communicator,
index e88431e99aa9a0a035a2a4f36d927e5d6c5ecef6..73380c1e0f213da710dd540026e74ec4973a0326 100644 (file)
@@ -528,9 +528,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_parallel_sparse_matrix.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_parallel_sparse_matrix.h
- * ---------------------------*/
+/*---------------------- petsc_parallel_sparse_matrix.h ---------------------*/
index cd044278e24526829e16cd3fda5c741b5221e722..bec4b2c8d2b3fdcc98c9808980a974ec36bad7fe 100644 (file)
@@ -569,9 +569,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_parallel_vector.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_parallel_vector.h
- * ---------------------------*/
+/*------------------------- petsc_parallel_vector.h -------------------------*/
index 17dedf88aa3b0d52e21d478303bfad5714825805..4eb52c6b3b0800ddff1142488ae3a53af7b52a4b 100644 (file)
@@ -970,9 +970,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_precondition.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_precondition.h
- * ---------------------------*/
+/*--------------------------- petsc_precondition.h --------------------------*/
index fcf33d07a8cdb0e2a75bb6e0c22f3d62db09f46c..37976093dbf808cc275576970fcd0ee0785507c1 100644 (file)
@@ -290,9 +290,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_sparse_matrix.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_sparse_matrix.h
- * ---------------------------*/
+/*--------------------------- petsc_sparse_matrix.h -------------------------*/
index 145b2dbb93fe03286d12b9805c71d99e54829e9a..a31bd9d74837974edbd7dd0b4506988da010280b 100644 (file)
@@ -1246,9 +1246,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_PETSC
 
-/*----------------------------   petsc_vector_base.h
- * ---------------------------*/
-
 #endif
-/*----------------------------   petsc_vector_base.h
- * ---------------------------*/
+/*---------------------------- petsc_vector_base.h --------------------------*/
index d3833d734039d19a83c2fccae4f93d471465ea07..cd11dd677b76aab69609b5792a856d2e077bce39 100644 (file)
@@ -705,8 +705,7 @@ namespace LinearAlgebra
   /*@}*/
 
 
-  /*----------------------- Inline functions
-   * ----------------------------------*/
+  /*---------------------------- Inline functions ---------------------------*/
 
 #ifndef DOXYGEN
 
index 3f5da19ebe09137f8357dfb79a230d5e7c698c14..b5ae7283cd1b5774df5dcb3a87c1a79dd3a71e04 100644 (file)
@@ -249,7 +249,8 @@ public:
   copy_transposed(const ScaLAPACKMatrix<NumberType> &B);
 
   /**
-   * The operations based on the input parameter @p transpose_B and the alignment conditions are summarized in the following table:
+   * The operations based on the input parameter @p transpose_B and the
+   * alignment conditions are summarized in the following table:
    *
    * | transpose_B |          Block Sizes         |                    Operation
    * | | :---------: | :--------------------------: |
index 451837ec646b7a00bc91abb0a7bc1ddcb6149b94..5e4ea2bf7219e60925e817063317947de0aa2cd7 100644 (file)
@@ -305,13 +305,7 @@ SparseILU<number>::memory_consumption() const
   return SparseLUDecomposition<number>::memory_consumption();
 }
 
-
-
-/*----------------------------   sparse_ilu.templates.h
- * ---------------------------*/
-
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
-/*----------------------------   sparse_ilu.templates.h
- * ---------------------------*/
+/*-------------------------- sparse_ilu.templates.h -------------------------*/
index e540868341083d86a0b97fd472a0ff784fd6e3c4..189a89b5e9e894991793b2ddc7177c3344cc281c 100644 (file)
@@ -225,11 +225,7 @@ private:
 };
 
 /*@}*/
-/*----------------------------   swappable_vector.h
- * ---------------------------*/
-/* end of #ifndef dealii_swappable_vector_h */
 DEAL_II_NAMESPACE_CLOSE
 
-#endif
-/*----------------------------   swappable_vector.h
- * ---------------------------*/
+#endif // dealii_swappable_vector_h
+/*---------------------------   swappable_vector.h --------------------------*/
index e7f5c71c3e8c490661f81905245170abf30298df..732ffe27f38fc88e1074b188a4a83e664958caef 100644 (file)
@@ -613,8 +613,7 @@ TensorProductMatrixSymmetricSumBase<dim, Number, size>::apply_inverse(
 }
 
 
-// ------------------------------   TensorProductMatrixSymmetricSum
-// ------------------------------
+//---------------------- TensorProductMatrixSymmetricSum ----------------------
 
 template <int dim, typename Number, int size>
 inline TensorProductMatrixSymmetricSum<dim, Number, size>::
@@ -740,8 +739,7 @@ TensorProductMatrixSymmetricSum<dim, Number, size>::reinit(
 
 
 
-// ------------------------------ vectorized spec.:
-// TensorProductMatrixSymmetricSum   ------------------------------
+//------------- vectorized spec.: TensorProductMatrixSymmetricSum -------------
 
 template <int dim, typename Number, int size>
 inline TensorProductMatrixSymmetricSum<dim, VectorizedArray<Number>, size>::
index 280c1f19ca502e8f6a412a306023fbd51282b5d0..9958e67a3d4408eca6cb949ba7bbd61f4b91edde 100644 (file)
@@ -310,8 +310,7 @@ namespace TrilinosWrappers
 
 
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*-------------------------- Inline functions ---------------------------*/
     inline BlockVector::BlockVector(
       const std::vector<IndexSet> &parallel_partitioning,
       const MPI_Comm &             communicator)
index 0e03e9098105f7c266524d8128354a736a84129d..6ccaa0cca03cb9c73dbe80913d0212c6271eca8f 100644 (file)
@@ -1940,8 +1940,7 @@ namespace TrilinosWrappers
 
 
 
-  // -------------------------- inline and template functions
-  // ----------------------
+  // ----------------------- inline and template functions --------------------
 
 
 #    ifndef DOXYGEN
@@ -2105,9 +2104,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_TRILINOS
 
-/*----------------------------   trilinos_precondition.h
- * ---------------------------*/
-
-#endif
-/*----------------------------   trilinos_precondition.h
- * ---------------------------*/
+#endif // trilinos_precondition_h
+/*------------------------- trilinos_precondition.h -------------------------*/
index 97c95e251e0c2e17a3f47f76712f8882c378e66f..e40f2dd66ccec03ee7179d4da6b069e21f71e0b1 100644 (file)
@@ -2635,8 +2635,7 @@ namespace TrilinosWrappers
 
 
 
-  // -------------------------- inline and template functions
-  // ----------------------
+  // ----------------------- inline and template functions --------------------
 
 #    ifndef DOXYGEN
 
index 07c2f1055fff13ea56b3191f481329f78dde1ebc..f369814a1cf3c5b5c272465889fc0319d2d2d69f 100644 (file)
@@ -1232,8 +1232,7 @@ namespace TrilinosWrappers
 
 
 
-  // -------------------------- inline and template functions
-  // ----------------------
+  // ----------------------- inline and template functions --------------------
 
 
 #    ifndef DOXYGEN
index 273ad2054e2e690c018dc0e4ce177da1458e42f0..f97710630d721a37187dde9d99f96efb100eda4a 100644 (file)
@@ -517,8 +517,7 @@ namespace internal
     };
 
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*-------------------------- Inline functions ---------------------------*/
 
 #ifndef DOXYGEN
 
index d958079b453de9e960751535d9a0db2d1c016ece..4b5ec4b3ffe2a8fe5a68119b4c6c5b20ff4cfdf2 100644 (file)
@@ -5840,8 +5840,7 @@ FEEvaluationAccess<dim, dim, Number, is_face>::submit_curl(
 }
 
 
-/*-------------------- FEEvaluationAccess scalar for 1d
- * ----------------------------*/
+/*-------------------- FEEvaluationAccess scalar for 1d ---------------------*/
 
 
 template <typename Number, bool is_face>
index 88b64909bb7fad05c10c7b4ae0cc494919341f4b..b4bef0c38f9a6a2de106e93e0d481361f610c3de 100644 (file)
@@ -154,8 +154,7 @@ namespace internal
     };
 
 
-    /*----------------------- Inline functions
-     * ----------------------------------*/
+    /*-------------------------- Inline functions ---------------------------*/
 
     template <int dim, typename Number>
     inline MappingDataOnTheFly<dim, Number>::MappingDataOnTheFly(
index c809c134d3bd0053a46a662e4b774109b878b893..3ec899a49b1fb57087de0b2dff0e24f769a2d02c 100644 (file)
@@ -486,8 +486,7 @@ private:
 
 /*@}*/
 
-//----------inline function
-// definition--------------------------------------------------
+//------------------------- inline function definition ------------------------
 template <typename number>
 inline void
 MGTransferBlockSelect<number>::select(const unsigned int block)
index bba72099594eb537d56fe644b4574f53567143e9..28920d3da569dc69d0ca5793cac8aff8180e9b25 100644 (file)
@@ -536,9 +536,5 @@ private:
 
 DEAL_II_NAMESPACE_CLOSE
 
-
-/*----------------------------   solutiontransfer.h
- * ---------------------------*/
-#endif
-/*----------------------------   solutiontransfer.h
- * ---------------------------*/
+#endif // dealii_solutiontransfer_h
+/*---------------------------- solutiontransfer.h ---------------------------*/
index 13c0654c003a165c02dd05250a00e11a1920cee7..d7a9a5c9b01055900f40dba6d8628be3b7c07b00 100644 (file)
@@ -1515,8 +1515,7 @@ private:
 
 
 
-/*----------------------------- template functions
- * ------------------------------*/
+/*--------------------------- template functions ----------------------------*/
 
 template <typename InitFunctionObject, typename LoopFunctionObject>
 void
index e08b9f94e2f8fab83ffaaded01a18d303dd1f17c..67b1d22127698d4edb8f197226bb1a4a860fe6ac 100644 (file)
@@ -3643,8 +3643,7 @@ namespace VectorTools
   }
 
 
-  // ----- implementation for project_boundary_values with ConstraintMatrix
-  // -----
+  // ---- implementation for project_boundary_values with ConstraintMatrix ----
 
 
 
index 234f4ed8528050cbde80afda36b602e630ad4781..44b6d8618cacc84f2645b67d2b7385de8a1dbf0d 100644 (file)
@@ -189,8 +189,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_OPENCASCADE
 
-/*------------------------------ occ_boundary_lib.h
- * ------------------------------*/
-#endif
-/*------------------------------ occ_boundary_lib.h
- * ------------------------------*/
+#endif // dealii_occ_boundary_lib_h
+/*---------------------------- occ_boundary_lib.h ---------------------------*/
index 5abbec65bc29bf803f80dde486f3bb9dcd0ddac6..5eb894502312c32431d929aec8a9ecc12ecfc66d 100644 (file)
@@ -438,8 +438,5 @@ DEAL_II_NAMESPACE_CLOSE
 
 #  endif // DEAL_II_WITH_OPENCASCADE
 
-/*------------------------------ occ_utilities.h
- * ------------------------------*/
-#endif
-/*------------------------------ occ_utilities.h
- * ------------------------------*/
+#endif // dealii_occ_utilities_h
+/*----------------------------- occ_utilities.h -----------------------------*/
index 2ea3a8744092d8bce21a3f788282ea28afd76f6b..19d69197f0cae331f86c305338ea7bf3b0ec04c4 100644 (file)
@@ -325,8 +325,7 @@ namespace Particles
     PropertyPool::Handle properties;
   };
 
-  /* -------------------------- inline and template functions
-   * ---------------------- */
+  /* ---------------------- inline and template functions ------------------ */
 
   template <int dim, int spacedim>
   template <class Archive>
index 1e7afccd6c681585c9447184ecfebb3038b28848..20525220d739823a1b1d77b49c5ad4cac24a56d6 100644 (file)
@@ -524,8 +524,7 @@ namespace Particles
       const void *                                                data);
   };
 
-  /* -------------------------- inline and template functions
-   * ---------------------- */
+  /* ---------------------- inline and template functions ------------------ */
 
   template <int dim, int spacedim>
   template <class Archive>
index 480f12588e1921060cd19282432a8e4b54fd89db..991f5a5b9cecb26991c272b9682153c220d00852 100644 (file)
@@ -1333,8 +1333,7 @@ namespace parallel
 {
   namespace distributed
   {
-    /* ---------------------- class Triangulation<dim,spacedim>
-     * ------------------------------ */
+    /* ----------------- class Triangulation<dim,spacedim> ----------------- */
 
 
     template <int dim, int spacedim>
index 8e5cc2740e0b666992d5edfb3dea1dfdf4055f01..3996c531897a1ebba5e95821069ba4259d501419 100644 (file)
@@ -28,8 +28,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-/*------------------------- Static variables: DoFAccessor
- * -----------------------*/
+/* --------------------- Static variables: DoFAccessor --------------------- */
 
 template <int structdim, typename DoFHandlerType, bool level_dof_access>
 const unsigned int
@@ -41,8 +40,7 @@ const unsigned int
 
 
 
-/*------------------------ Functions: DoFInvalidAccessor
- * ---------------------------*/
+/* ---------------------- Functions: DoFInvalidAccessor -------------------- */
 
 template <int structdim, int dim, int spacedim>
 DoFInvalidAccessor<structdim, dim, spacedim>::DoFInvalidAccessor(
index ea679e5d050344d0c85bf2fc635d7bd1a0a9bc80..1797905dd88fd2113978218adf1bfea1ee88a6c6 100644 (file)
@@ -2753,8 +2753,7 @@ public:
                               Vector<IndexSet::value_type> &out) const = 0;
 };
 
-/* ---------------- classes derived from
- * FEValuesBase<dim,spacedim>::CellIteratorBase --------- */
+/* --- classes derived from FEValuesBase<dim,spacedim>::CellIteratorBase --- */
 
 
 /**
@@ -4907,8 +4906,7 @@ FEFaceValues<dim, spacedim>::do_reinit(const unsigned int face_no)
 }
 
 
-/*------------------------------- FESubFaceValues
- * -------------------------------*/
+/* ---------------------------- FESubFaceValues ---------------------------- */
 
 
 template <int dim, int spacedim>
index a2479e87209a60b721d76992e0a31c96edfaffe2..662666a03b7a3619a87bbb53ea082429a7c060ad 100644 (file)
@@ -71,8 +71,7 @@ Mapping<dim, spacedim>::project_real_point_to_unit_point_on_face(
   return unit_face_pt;
 }
 
-/*------------------------------ InternalDataBase
- * ------------------------------*/
+/* ---------------------------- InternalDataBase --------------------------- */
 
 
 template <int dim, int spacedim>
index 85d26bd8d3b967a54761736116bcdd73b10ab883..0b477a70f826f8a97c84c7683817dd4f5fc4d33c 100644 (file)
@@ -1424,8 +1424,7 @@ namespace
 
 
 
-/*------------------------ Static variables: TriaAccessorBase
- * ---------------------------*/
+/*-------------------- Static variables: TriaAccessorBase -------------------*/
 
 template <int structdim, int dim, int spacedim>
 const unsigned int TriaAccessorBase<structdim, dim, spacedim>::dimension;
@@ -1900,8 +1899,7 @@ CellAccessor<3>::point_inside(const Point<3> &p) const
 
 
 
-/*------------------------ Functions: CellAccessor<dim,spacedim>
- * -----------------------*/
+/*------------------- Functions: CellAccessor<dim,spacedim> -----------------*/
 
 // For codim>0 we proceed as follows:
 // 1) project point onto manifold and
index cdd6d6a973b69f66fb05ad11eb0339e33d6ddc9b..8c861825000674504292aed31a94b08453b59643 100644 (file)
@@ -54,8 +54,7 @@ DataPostprocessor<dim>::get_data_component_interpretation() const
 }
 
 
-// -------------------------- DataPostprocessorScalar
-// ---------------------------
+// -------------------------- DataPostprocessorScalar -------------------------
 
 template <int dim>
 DataPostprocessorScalar<dim>::DataPostprocessorScalar(
@@ -94,8 +93,7 @@ DataPostprocessorScalar<dim>::get_needed_update_flags() const
 
 
 
-// -------------------------- DataPostprocessorVector
-// ---------------------------
+// -------------------------- DataPostprocessorVector -------------------------
 
 template <int dim>
 DataPostprocessorVector<dim>::DataPostprocessorVector(
@@ -134,8 +132,7 @@ DataPostprocessorVector<dim>::get_needed_update_flags() const
 
 
 
-// -------------------------- DataPostprocessorTensor
-// ---------------------------
+// -------------------------- DataPostprocessorTensor -------------------------
 
 template <int dim>
 DataPostprocessorTensor<dim>::DataPostprocessorTensor(
index 727dabd0cdf24fc209397a8180aa8b7e6778439b..2b98ae709c757b711c48af1c8ec1a6e4436c3665 100644 (file)
@@ -60,8 +60,7 @@ namespace
   }
 } // namespace
 
-// --------------- First the classes and functions that describe individual
-// --------------- derivatives
+// --- First the classes and functions that describe individual derivatives ---
 
 namespace DerivativeApproximation
 {
@@ -727,8 +726,7 @@ namespace DerivativeApproximation
   }   // namespace internal
 } // namespace DerivativeApproximation
 
-// ------------------------------- now for the functions that do the
-// ------------------------------- actual work
+// --------------- now for the functions that do the actual work --------------
 
 namespace DerivativeApproximation
 {
index 0f1ed5d37e7dd574faa98b6b4d64a7d4c039c830..7f69b963facacb9aab346c49e488d005570baef0 100644 (file)
@@ -189,8 +189,7 @@ check()
           << std::endl;
 
 
-  //--------------- Sparsity pattern checks for
-  //                boundary sparsity generators -----------------
+  //-------- Sparsity pattern checks for boundary sparsity generators --------
 
   // check boundary matrices
   check_boundary(dof);
index d44d75c5afaa579b85ab65e845db30447164dc43..3f10a99d6e8e707c845b60dd7dd4d76ad0951535 100644 (file)
@@ -189,8 +189,7 @@ check()
           << std::endl;
 
 
-  //--------------- Sparsity pattern checks for
-  //                boundary sparsity generators -----------------
+  //-------- Sparsity pattern checks for boundary sparsity generators ---------
 
   // check boundary matrices
   check_boundary(dof);
index 51c56d50de7a455a3930f9f15a5869016be0c132..9ad01f20f15596a7e1b09c9b5d691c37c4bc4343 100644 (file)
@@ -68,8 +68,7 @@ struct DisableWindowsDebugRuntimeDialog
 using namespace dealii;
 
 
-// ------------------------------ Utility functions used in tests
-// -----------------------
+// ------------------------- Utility functions used in tests ------------------
 
 /**
  * Go through the input stream @p in and filter out binary data for the key @p key .
@@ -394,8 +393,7 @@ filter_out_small_numbers(const Number number, const double tolerance)
     return number;
 }
 
-// ------------------------------ Functions used in initializing subsystems
-// -------------------
+// ---------------- Functions used in initializing subsystems -----------------
 
 
 /*
@@ -631,8 +629,7 @@ struct SetTBBAssertionHandler
 #endif /*TBB_DO_ASSERT*/
 
 
-// ------------------------------ Adjust global variables in deal.II
-// -----------------------
+// ---------------------- Adjust global variables in deal.II ------------------
 
 
 DEAL_II_NAMESPACE_OPEN

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.