]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix comments and style issues 256/head
authorMatthias Maier <tamiko@kyomu.43-1.org>
Thu, 20 Nov 2014 11:19:36 +0000 (12:19 +0100)
committerMatthias Maier <tamiko@kyomu.43-1.org>
Thu, 20 Nov 2014 11:25:15 +0000 (12:25 +0100)
doc/news/changes.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_tools.h

index c53ef70208e0305daf5074f232975728e379ca07..98d5e1ba562444379c5234137e8d5abf8b08d742 100644 (file)
@@ -333,8 +333,13 @@ inconvenience this causes.
 <h3>Specific improvements</h3>
 
 <ol>
-  <li> New: Complete the periodic boundary condition interface and add
-  support for rotating vector valued dof components.
+  <li> New: Complete the interface for periodic boundary conditions.
+  Now, it is possible to specify an additional (geometric) rotation matrix along
+  with vector components that should be rotated when applying periodic boundary
+  condiitions (or alternatively, directly a transformation matrix working
+  directly on dofs). With this it is e.g. now possible to to compute stokes flow
+  on a quarter pie with periodic boundary conditions and the velocity correctly
+  transformed.
   <br>
   (Daniel Arndt, Matthias Maier, 2014/11/19)
   </li>
index e7a696146316df5f63db4c7d4049ae7793b6e303..39603434bb1377ddf4fbaa55a0789114dfed56e3 100644 (file)
@@ -954,8 +954,7 @@ namespace DoFTools
    * FESystem.
    *
    * Detailed information can be found in the @see @ref
-   * GlossPeriodicConstraints "Glossary entry on periodic boundary
-   * conditions".
+   * GlossPeriodicConstraints "Glossary entry on periodic boundary conditions".
    *
    * @todo: Reference to soon be written example step and glossary article.
    *
@@ -991,8 +990,8 @@ namespace DoFTools
    * parallel::distributed::Triangulation::add_periodicity has to be called
    * before.
    *
-   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic
-   * boundary conditions" for further information.
+   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions"
+   * for further information.
    *
    * @author Daniel Arndt, Matthias Maier, 2013, 2014
    */
@@ -1011,7 +1010,7 @@ namespace DoFTools
    * conditions into a ConstraintMatrix @p constraint_matrix.
    *
    * This function serves as a high level interface for the
-   * make_periodicity_constraints function.
+   * make_periodicity_constraints() function.
    *
    * Define a 'first' boundary as all boundary faces having boundary_id
    * @p b_id1 and a 'second' boundary consisting of all faces belonging
@@ -1032,23 +1031,23 @@ namespace DoFTools
    * kept and nothing happens.
    *
    * The flags in the last parameter, @p component_mask (see @ref
-   * GlossComponentMask) denote which components of the finite element space
-   * shall be constrained with periodic boundary conditions. If it is left
-   * as specified by the default value all components are constrained. If
-   * it is different from the default value, it is assumed that the number
-   * of entries equals the number of components in the boundary functions
-   * and the finite element, and those components in the given boundary
-   * function will be used for which the respective flag was set in the
-   * component mask.
+   * GlossComponentMask) denote which components of the finite element
+   * space shall be constrained with periodic boundary conditions. If it is
+   * left as specified by the default value all components are constrained.
+   * If it is different from the default value, it is assumed that the
+   * number of entries equals the number of components in the boundary
+   * functions and the finite element, and those components in the given
+   * boundary function will be used for which the respective flag was set
+   * in the component mask.
    *
    * @note: This function is a convenience wrapper. It internally calls
-   * GridTools::collect_periodic_faces with the supplied paramaters and
-   * feeds the output to above make_periodicity_constraints variant. If you
-   * need more functionality use GridTools::collect_periodic_faces
+   * GridTools::collect_periodic_faces() with the supplied paramaters and
+   * feeds the output to above make_periodicity_constraints() variant. If
+   * you need more functionality use GridTools::collect_periodic_faces()
    * directly.
    *
-   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic
-   * boundary conditions" for further information.
+   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions"
+   * for further information.
    *
    * @author Matthias Maier, 2012
    */
@@ -1080,13 +1079,13 @@ namespace DoFTools
    * "standard orientation".
    *
    * @note: This function is a convenience wrapper. It internally calls
-   * GridTools::collect_periodic_faces with the supplied paramaters and
-   * feeds the output to above make_periodicity_constraints variant. If you
-   * need more functionality use GridTools::collect_periodic_faces
+   * GridTools::collect_periodic_faces() with the supplied paramaters and
+   * feeds the output to above make_periodicity_constraints() variant. If
+   * you need more functionality use GridTools::collect_periodic_faces()
    * directly.
    *
-   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic
-   * boundary conditions" for further information.
+   * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions"
+   * for further information.
    */
   template<typename DH>
   void
index fc1b9507de3abad522a6829c11227db33f762ff2..578b26c825f272a30ee0325780d2d23251f4b66f 100644 (file)
@@ -1072,8 +1072,8 @@ namespace GridTools
 
     /**
      * The relative orientation of the first face with respect to the
-     * second face as described in orthogonal_equality and
-     * make_periodicity_constraints (and stored as a bitset).
+     * second face as described in orthogonal_equality() and
+     * make_periodicity_constraints() (and stored as a bitset).
      */
     std::bitset<3> orientation;
 
@@ -1083,7 +1083,7 @@ namespace GridTools
      * face. If the std::vector first_vector_components is non empty the
      * matrix is interpreted as a rotation matrix that is applied to all
      * vector valued blocks listed in first_vector_components of the
-     * FESystem. For more details see make_periodicity_constraints and the
+     * FESystem. For more details see make_periodicity_constraints() and the
      * glossary @ref GlossPeriodicConstraints "glossary entry on periodic
      * boundary conditions".
      */
@@ -1206,22 +1206,22 @@ namespace GridTools
    * them to the corresponding vertices of the 'second' boundary. This can
    * be used to implement conditions such as $u(0,y)=u(1,y+1)$.
    *
-   * Optionally a rotation matrix @p matrix along with a vector @p
-   * first_vector_components can be specified that describes how vector
+   * Optionally a (dim x dim) rotation matrix @p matrix along with a vector
+   * @p first_vector_components can be specified that describes how vector
    * valued DoFs of the first face should be modified prior to constraining
    * to the DoFs of the second face. If @p first_vector_components is non
    * empty the matrix is interpreted as a rotation matrix that is applied
-   * to all vector valued blocks listet in @p first_vector_components of
-   * the FESystem. For more details see make_periodicity_constraints and
-   * the glossary @ref GlossPeriodicConstraints "glossary entry on periodic
-   * boundary conditions".
+   * to all vector valued blocks listed in @p first_vector_components of
+   * the FESystem. For more details see make_periodicity_constraints() and
+   * the glossary
+   * @ref GlossPeriodicConstraints "glossary entry on periodic boundary conditions".
    *
-   * @tparam Container A type that satisfies the
-   *   requirements of a mesh container (see @ref GlossMeshAsAContainer).
+   * @tparam Container A type that satisfies the requirements of a mesh
+   * container (see @ref GlossMeshAsAContainer).
    *
    * @note The created std::vector can be used in
-   * DoFTools::make_periodicity_constraints and in
-   * parallel::distributed::Triangulation::add_periodicity to enforce
+   * DoFTools::make_periodicity_constraints() and in
+   * parallel::distributed::Triangulation::add_periodicity() to enforce
    * periodicity algebraically.
    *
    * @note Because elements will be added to @p matched_pairs (and existing
@@ -1234,14 +1234,14 @@ namespace GridTools
   template <typename CONTAINER>
   void
   collect_periodic_faces
-  (const CONTAINER          &container,
-   const types::boundary_id b_id1,
-   const types::boundary_id b_id2,
-   const int                direction,
+  (const CONTAINER                                                   &container,
+   const types::boundary_id                                           b_id1,
+   const types::boundary_id                                           b_id2,
+   const int                                                          direction,
    std::vector<PeriodicFacePair<typename CONTAINER::cell_iterator> > &matched_pairs,
-   const Tensor<1,CONTAINER::space_dimension> &offset = dealii::Tensor<1,CONTAINER::space_dimension>(),
-   const FullMatrix<double> &matrix = FullMatrix<double>(IdentityMatrix(CONTAINER::space_dimension)),
-   const std::vector<unsigned int> &first_vector_components = std::vector<unsigned int>());
+   const Tensor<1,CONTAINER::space_dimension>                        &offset = dealii::Tensor<1,CONTAINER::space_dimension>(),
+   const FullMatrix<double>                                          &matrix = FullMatrix<double>(IdentityMatrix(CONTAINER::space_dimension)),
+   const std::vector<unsigned int>                                   &first_vector_components = std::vector<unsigned int>());
 
 
   /**
@@ -1258,13 +1258,13 @@ namespace GridTools
    * This function will collect periodic face pairs on the coarsest mesh level
    * and add them to @p matched_pairs leaving the original contents intact.
    *
-   * Optionally a rotation matrix @p matrix along with a vector @p
-   * first_vector_components can be specified that describes how vector
+   * Optionally a rotation matrix @p matrix along with a vector
+   * @p first_vector_components can be specified that describes how vector
    * valued DoFs of the first face should be modified prior to constraining
    * to the DoFs of the second face. If @p first_vector_components is non
    * empty the matrix is interpreted as a rotation matrix that is applied
    * to all vector valued blocks listet in @p first_vector_components of
-   * the FESystem. For more details see make_periodicity_constraints and
+   * the FESystem. For more details see make_periodicity_constraints() and
    * the glossary @ref GlossPeriodicConstraints "glossary entry on periodic
    * boundary conditions".
    *
@@ -1280,13 +1280,13 @@ namespace GridTools
   template <typename CONTAINER>
   void
   collect_periodic_faces
-  (const CONTAINER          &container,
-   const types::boundary_id b_id,
-   const int                direction,
+  (const CONTAINER                                                   &container,
+   const types::boundary_id                                           b_id,
+   const int                                                          direction,
    std::vector<PeriodicFacePair<typename CONTAINER::cell_iterator> > &matched_pairs,
-   const dealii::Tensor<1,CONTAINER::space_dimension> &offset = dealii::Tensor<1,CONTAINER::space_dimension>(),
-   const FullMatrix<double> &matrix = FullMatrix<double>(),
-   const std::vector<unsigned int> &first_vector_components = std::vector<unsigned int>());
+   const dealii::Tensor<1,CONTAINER::space_dimension>                &offset = dealii::Tensor<1,CONTAINER::space_dimension>(),
+   const FullMatrix<double>                                          &matrix = FullMatrix<double>(),
+   const std::vector<unsigned int>                                   &first_vector_components = std::vector<unsigned int>());
 
 
   /*@}*/

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.