From a3659cb18bb4eebd38ae4e327a808d3c74e1631d Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 29 Jul 2014 15:02:15 -0500 Subject: [PATCH] Fix numerous doxygen markup problems. Doxygen got bent all out of shape in various places because formulas were opened but not closed, and a number of other markup problems as well. --- doc/news/3.1.0-vs-3.2.0.h | 2 +- doc/news/5.2.0-vs-6.0.0.h | 384 +++++++++---------------------- examples/step-32/doc/results.dox | 2 +- examples/step-42/doc/intro.dox | 1 - examples/step-52/step-52.cc | 2 +- examples/step-53/step-53.cc | 4 +- include/deal.II/dofs/dof_tools.h | 2 +- 7 files changed, 114 insertions(+), 283 deletions(-) diff --git a/doc/news/3.1.0-vs-3.2.0.h b/doc/news/3.1.0-vs-3.2.0.h index 20a2fa00aa..a13caa7ec6 100644 --- a/doc/news/3.1.0-vs-3.2.0.h +++ b/doc/news/3.1.0-vs-3.2.0.h @@ -57,7 +57,7 @@ All entries are signed with the names of the author.
  • Changed: If in multithreaded mode, the ACE library is now - automatically added to the $(LIBS) Makefile + automatically added to the \$(LIBS) Makefile variable. There is no need anymore for a special clause in your Makefile.
    diff --git a/doc/news/5.2.0-vs-6.0.0.h b/doc/news/5.2.0-vs-6.0.0.h index d92a0c0bdb..605e4b6c29 100644 --- a/doc/news/5.2.0-vs-6.0.0.h +++ b/doc/news/5.2.0-vs-6.0.0.h @@ -46,10 +46,8 @@ inconvenience this causes. (GK 2007/08/22)

    -
  • Changed: Implementing gradients for the class FunctionDerivative, it became evident that its enums for - difference formulas clashed with those of AutoDerivativeFunction. Therefore, only the latter +

  • Changed: Implementing gradients for the class FunctionDerivative, it became evident that its enums for + difference formulas clashed with those of AutoDerivativeFunction. Therefore, only the latter survived.
    (GK 2007/08/02) @@ -86,28 +84,15 @@ inconvenience this causes.

  • Changed: Lower dimensional objects have been removed from the - hierarchical structure of levels in TriaLevel. Faces, i.e. lines in 2D and + hierarchical structure of levels in TriaLevel. Faces, i.e. lines in 2D and lines and quads in 3D, have no associated level anymore. Therefore, the level argument of some iterator - functions have been removed. The affected functions are Triangulation:: begin_raw_face, begin_face, begin_active_face and all last_*_face or end_*_face functions, no matter whether + functions have been removed. The affected functions are Triangulation::begin_raw_face, begin_face, begin_active_face and all last_*_face or end_*_face functions, no matter whether raw, used or active. Also effected are the direct iterator - functions which are related to faces like begin_line in 2D and 3D or begin_quad in 3D. Again, the same applies - to last_* and end_*. -
    - The respective functions in DoFHandler, hp::DoFHandler and MGDoFHandler have been changed + functions which are related to faces like begin_line in 2D and 3D or begin_quad in 3D. Again, the same applies + to last_* and end_*. +
    + The respective functions in DoFHandler, hp::DoFHandler and MGDoFHandler have been changed accordingly.
    Nested loops with an outer loop over all levels and an inner @@ -120,8 +105,7 @@ inconvenience this causes.

  • Changed: In order to facilitate the implementation of hp finite - elements, the ordering of boundary DoFs returned by DoFTools::map_dof_to_boundary_indices has been + elements, the ordering of boundary DoFs returned by DoFTools::map_dof_to_boundary_indices has been changed. Fortunately, this is a rarely used function so that the effect should be limited to only a few programs.
    @@ -129,8 +113,7 @@ inconvenience this causes.

  • - Changed: The distribute_local_to_global functions have + Changed: The distribute_local_to_global functions have been moved from the classes implementing accessors to arbitrary objects in the triangulation to the cell accessors, to facilitate the implementation of hp methods. That means @@ -142,12 +125,9 @@ inconvenience this causes.

  • - Changed: The template argument of the InterGridMap class has been changed. Code - like e.g. InterGridMap<DoFHandler,2> must be - replaced by InterGridMap<DoFHandler<2> >. + Changed: The template argument of the InterGridMap class has been changed. Code + like e.g. InterGridMap<DoFHandler,2> must be + replaced by InterGridMap<DoFHandler<2> >.
    (RH 2006/02/27)

    @@ -209,17 +189,13 @@ inconvenience this causes. possible. For more information on the new numbering scheme, see the announcement - on the mailing list.
    The ordering of vertices in CellData given to the Triangulation::create_triangulation + on the mailing list.
    The ordering of vertices in CellData given to the Triangulation::create_triangulation function has been changed accordingly. For backward - compatibility there is now a new Triangulation::create_triangulation_compatibility + compatibility there is now a new Triangulation::create_triangulation_compatibility function which takes CellData in the old vertex ordering. However, as this function might not be supported forever users are advised to change their code to the - new numbering scheme and to use the Triangulation::create_triangulation + new numbering scheme and to use the Triangulation::create_triangulation function.
    (RH 2005/11/02) @@ -325,10 +301,8 @@ inconvenience this causes. (WB 2006/08/09)

    -
  • Changed: The default number of subdivisions in the build_patches functions of the DataOut classes is - now part of the parameters read by parse_parameters. This default value is used +

  • Changed: The default number of subdivisions in the build_patches functions of the DataOut classes is + now part of the parameters read by parse_parameters. This default value is used whenever patches with zero subdivisions are being built.
    (GK 2006/06/18) @@ -633,8 +607,7 @@ inconvenience this causes. (Ralf B. Schulz 2006/05/10)

    -
  • Improved: DataOutBase::OutputFormat has a new value none, +

  • Improved: DataOutBase::OutputFormat has a new value none, writing no output at all. This way, the writing of output files can be controlled more easily from parameter files.
    @@ -655,8 +628,7 @@ inconvenience this causes. (WB 2006/03/24)

    -
  • New: The new deal_II_numbers::is_finite function can +

  • New: The new deal_II_numbers::is_finite function can be used to check whether a floating point number is finite, i.e. neither plus or minus infinite nor NaN (not a number); it is in the new include file base/numbers.h, which will @@ -671,15 +643,13 @@ inconvenience this causes. (WB 2006/03/14)

    -
  • Improved: The function Subscriptor::list_subscribers logs all current subscribers of an +

  • Improved: The function Subscriptor::list_subscribers logs all current subscribers of an object to deallog.
    (GK 2006/03/08)

    -
  • Fixed: Writing a denormal "NaN" through LogStream objects such as +

  • Fixed: Writing a denormal "NaN" through LogStream objects such as deallog erroneously printed zero, rather than "nan". This is now fixed.
    @@ -730,8 +700,7 @@ inconvenience this causes. (WB 2006/02/12)

    -
  • Improved: A new function TableBase::fill, filling the whole table with the same +

  • Improved: A new function TableBase::fill, filling the whole table with the same element has been introduced.
    (GK 2006/01/18) @@ -761,16 +730,14 @@ inconvenience this causes.

  • Fixed: The computation of HMIN and - HMAX in DataOutBase::write_povray has been + HMAX in DataOutBase::write_povray has been wrong. This is now fixed.
    (RH 2005/11/02)

  • - Fixed: DataOutBase<2,3>::write_tecplot_binary + Fixed: DataOutBase<2,3>::write_tecplot_binary did not write the z coordinates. This is now fixed.
    @@ -778,21 +745,15 @@ inconvenience this causes.

  • - Fixed: The tecplot_binary OutputFormat has been added to DataOutBase::get_output_format_names. Now - an exception will be raised if write_tecplot_binary is invoked without - specifying the filename through the DataOutBase::TecplotFlags interface. + Fixed: The tecplot_binary OutputFormat has been added to DataOutBase::get_output_format_names. Now + an exception will be raised if write_tecplot_binary is invoked without + specifying the filename through the DataOutBase::TecplotFlags interface.
    (RH 2005/09/23)

  • - New: There are now new get_n_mpi_processes and get_this_mpi_process functions in the + New: There are now new get_n_mpi_processes and get_this_mpi_process functions in the Utilities::System namespace. In case of a code not running in parallel, they simply return 1 and 0, respectively. @@ -807,8 +768,7 @@ inconvenience this causes.

    lac

      -
    1. Changed: The CompressedBlockSparsityPattern has been renamed to +

    2. Changed: The CompressedBlockSparsityPattern has been renamed to BlockCompressedSparsityPattern to be consistent, since the "block" part builds on the "compressed sparsity pattern", not the other way around. The old name remains as a typedef, @@ -818,11 +778,9 @@ inconvenience this causes.

    3. New: The CompressedSetSparsityPattern - class is an alternative to the CompressedSparsityPattern class that appears to be + class is an alternative to the CompressedSparsityPattern class that appears to be better suited for problems that have many entries per row. There is also - a block version, BlockCompressedSetSparsityPattern. The two new + a block version, BlockCompressedSetSparsityPattern. The two new classes can used in all places where a regular compressed sparsity pattern can also be used.
      @@ -840,8 +798,7 @@ inconvenience this causes. to run the sparse direct solver as a separate program (the detached_ma27 program) rather than as part of the current program in order to be able to run several instances of it in parallel - during multithreaded computations. However, the destructor of the SparseDirectMA27 class had a bug that when using + during multithreaded computations. However, the destructor of the SparseDirectMA27 class had a bug that when using this detached mode led to a segmentation fault. This is now fixed.
      (WB 2007/02/09) @@ -869,8 +826,7 @@ inconvenience this causes. (Florian Prill 2006/12/18)

      -
    4. Improved: The SparsityPattern class would produce +

    5. Improved: The SparsityPattern class would produce segmentation faults if one tried to allocate a matrix with more than about 4.2 billion elements (i.e. the number that one can store in a 32-bit unsigned integer). This is now fixed: if you @@ -887,18 +843,15 @@ inconvenience this causes. (WB 2006/12/14)

      -
    6. New: The class PointerMatrixVector implements the functions - vmult and Tvmult for a 1xn-matrix represented by +

    7. New: The class PointerMatrixVector implements the functions + vmult and Tvmult for a 1xn-matrix represented by a single vector.
      (GK 2006/09/17)

    8. Improved: The class SolverCG can - now estimate the condition number of the linear system using TridiagonalMatrix and LAPACK. + now estimate the condition number of the linear system using TridiagonalMatrix and LAPACK.
      (GK 2006/09/06)

      @@ -924,22 +877,19 @@ inconvenience this causes. (GK 2006/07/07)

      -
    9. New: There is now a function FullMatrix::trace that does what its name suggests +

    10. New: There is now a function FullMatrix::trace that does what its name suggests it does.
      (WB 2006/06/16)

    11. Improved: PointerMatrixAux now has a - default constructor and a function for setting the VectorMemory object. + default constructor and a function for setting the VectorMemory object.
      (GK 2006/06/14)

      -
    12. Fixed: FullMatrix::print would yield a link error +

    13. Fixed: FullMatrix::print would yield a link error when used with std::ofstream since an explicit instantiation was missing. The function has now been moved to the header file and made inline so that it is always visible, @@ -948,24 +898,21 @@ inconvenience this causes. (WB 2006/06/07)

      -
    14. Improved: The SparseDirectUMFPACK solver can now also be +

    15. Improved: The SparseDirectUMFPACK solver can now also be used with sparse matrices with elements of type float, as well as with block matrices with types float and double.
      (WB 2006/04/25)

      -
    16. New: The function BlockSparsityPattern::row_length adds up +

    17. New: The function BlockSparsityPattern::row_length adds up the row lengths of the individual blocks of a block matrix for a given row.
      (WB 2006/04/25)

      -
    18. New: There is a new class IdentityMatrix that represents an +

    19. New: There is a new class IdentityMatrix that represents an efficient version of the matrix with ones on the diagonal and zeros everywhere else. The main usefulness of this matrix lies in the fact that most other important matrix classes have @@ -976,17 +923,14 @@ inconvenience this causes. (WB 2006/04/24)

      -
    20. New: There are now assignment operators from BlockVector to Vector and back. +

    21. New: There are now assignment operators from BlockVector to Vector and back.
      (WB 2006/03/30)

    22. Improved: BlockSparsityPattern can be initialized directly using the vector generated by - DoFTools::compute_row_length_vector. + DoFTools::compute_row_length_vector.
      (GK 2006/03/30)

      @@ -1002,20 +946,16 @@ inconvenience this causes.

    23. - Changed: There are new FullMatrix::equ functions which assign this + Changed: There are new FullMatrix::equ functions which assign this matrix to the linear combination of one, two or three - matrices. Also there is now a new Vector::equ + matrices. Also there is now a new Vector::equ function for three vectors.
      (RH 2006/02/21)

    24. - Fixed: The SolverMinRes class did not work + Fixed: The SolverMinRes class did not work with the BlockVector class. This is now fixed.
      @@ -1023,32 +963,21 @@ inconvenience this causes.

    25. - Changed: There are now new FullMatrix::add functions which add two and three + Changed: There are now new FullMatrix::add functions which add two and three scaled matrices.
      (RH 2006/02/16)

    26. - Changed: The matrix classes FullMatrix, SparseMatrix, SparseMatrixEZ and BlockMatrixBase now have an add function analogous to the add of vector classes. The old add_scaled functions are now deprecated. + Changed: The matrix classes FullMatrix, SparseMatrix, SparseMatrixEZ and BlockMatrixBase now have an add function analogous to the add of vector classes. The old add_scaled functions are now deprecated.
      (RH 2006/02/16)

    27. - Improved: BlockMatrixArray::enter_aux allows using matrices without - adding vector multiplication by using PointerMatrixAux. + Improved: BlockMatrixArray::enter_aux allows using matrices without + adding vector multiplication by using PointerMatrixAux.
      (GK 2006/02/02)

      @@ -1074,8 +1003,7 @@ inconvenience this causes.

    28. - New: All solver classes took an argument of type VectorMemory which they use to allocate + New: All solver classes took an argument of type VectorMemory which they use to allocate memory for temporary vectors. A clever implementation of this class might allow reusing temporary vectors, and thus reduce the overhead of repeatedly allocating and freeing @@ -1190,9 +1118,7 @@ inconvenience this causes. (Luca Heltai 2007/05/15)

      -
    29. New: The classes MGTransferBlockSelect and MGTransferBlock allow for transfer of multigrid +

    30. New: The classes MGTransferBlockSelect and MGTransferBlock allow for transfer of multigrid vectors for single blocks of a system and for several blocks.
      (GK 2007/04/26) @@ -1255,16 +1181,14 @@ inconvenience this causes. (WB 2007/02/20)

      -
    31. New: Added function GridGenerator::hyper_cube_with_cylindrical_hole that produces +

    32. New: Added function GridGenerator::hyper_cube_with_cylindrical_hole that produces a square with a circular hole in the middle in 2d, and extrudes it along the z-direction between 0 and L.
      (Luca Heltai 2007/02/15)

      -
    33. Workaround: The class GridOut::write_msh produces a mesh which can be visualized +

    34. Workaround: The class GridOut::write_msh produces a mesh which can be visualized in the Gmsh reader. A bug in Gmsh prevented the boundary indicator to be properly visualized. The boundary indicator was added to the material flag of the faces (which is ignored when reading back the @@ -1275,8 +1199,7 @@ inconvenience this causes.

      -
    35. Fixed: The function DoFTools::distribute_cell_to_dof_vector produced +

    36. Fixed: The function DoFTools::distribute_cell_to_dof_vector produced wrong results if the vector into which the result is to be stored contained nonzero values. This is now fixed.
      @@ -1291,8 +1214,7 @@ inconvenience this causes. (WB 2007/02/09)

      -
    37. Fixed: MatrixCreator::create_mass_matrix and +

    38. Fixed: MatrixCreator::create_mass_matrix and create_laplace_matrix computed wrong values for the right hand sides. This has been fixed.
      @@ -1304,19 +1226,13 @@ inconvenience this causes. defaults to false. It is set to true if the coordinates of the points defining the subdivision of a patch are appended to the data table contained in a - Patch. This way, DataOut::build_patches() can use a Mapping to represent curved boundaries, + Patch. This way, DataOut::build_patches() can use a Mapping to represent curved boundaries, especially for higher order elements. This change corresponds to an extension of the intermediate format for graphics.
      Fixed: Using the given Mapping to - obtain function values in DataOut::build_patches() also fixes a bug for - FE_RaviartThomas and FE_ABFelements, which need to evaluate the + obtain function values in DataOut::build_patches() also fixes a bug for + FE_RaviartThomas and FE_ABFelements, which need to evaluate the function values on the real (mapped) cell.
      (Tobias Leicht 2007/01/30) @@ -1325,16 +1241,14 @@ inconvenience this causes.

    39. Fixed: On faces with wrong face_orientation the dofs have to reordered in order to be combined with the correct shape functions. This is only relevant for continuous elements in 3D. At least for - FE_Q and systems of FE_Q this works now, for other finite elements the + FE_Q and systems of FE_Q this works now, for other finite elements the reordering vector still has to be implemented.
      (Tobias Leicht, 2007/01/17)

    40. - Fixed: The Triangulation::execute_coarsening_and_refinement function has to + Fixed: The Triangulation::execute_coarsening_and_refinement function has to discard coarsening flags in 2d and 3d if a neighbor of a flagged cell is refined or will be refined, in order to avoid that we end up with neighboring cells that differ in refinement by two levels. The function @@ -1376,9 +1290,7 @@ inconvenience this causes.

    41. - Extended: So far, the GridReordering::invert_all_cells_of_negative_grid + Extended: So far, the GridReordering::invert_all_cells_of_negative_grid function did nothing in 2d. Now, it inverts cells from clockwise to counterclockwise sense (in the old numbering scheme). @@ -1387,9 +1299,7 @@ inconvenience this causes.

    42. - New: There is now a function GridTools::delete_duplicated_vertices that deletes + New: There is now a function GridTools::delete_duplicated_vertices that deletes duplicate vertices which can occur if structured grids are read into deal.II, leading to unwanted interior boundaries. In order to reduce the effort of the quadratic @@ -1400,9 +1310,7 @@ inconvenience this causes.

    43. - New: There are now two new functions GridGenerator::subdivided_hyper_rectangle that produces + New: There are now two new functions GridGenerator::subdivided_hyper_rectangle that produces a non-uniformly subdivided rectangle, ideally suited for graded meshes. One of these functions is able to create meshes with holes.
      @@ -1416,12 +1324,8 @@ inconvenience this causes. (Florian Prill 2006/10/31)

      -
    44. Improved: The lookup mechanism in FETools::get_fe_from_name has been changed, so - additional custom finite elements can be added using FETools::add_fe_name. In the course of this +

    45. Improved: The lookup mechanism in FETools::get_fe_from_name has been changed, so + additional custom finite elements can be added using FETools::add_fe_name. In the course of this change, the implementation of the lookup mechanism has been simplified.
      @@ -1429,9 +1333,7 @@ inconvenience this causes.

    46. - New: There is a new functions GridTools::create_union_triangulation + New: There is a new functions GridTools::create_union_triangulation that generates a triangulation that contains the respectively finest cells of two input triangulations.
      @@ -1451,21 +1353,16 @@ inconvenience this causes.

    47. - New: There are new functions GridTools::minimal_cell_diameter and GridTools::maximal_cell_diameter, with obvious + New: There are new functions GridTools::minimal_cell_diameter and GridTools::maximal_cell_diameter, with obvious functionality.
      (WB 2006/09/06)

    48. - Changed: The functions FETools::compute_embedding_matrices, - FETools::compute_face_embedding_matrices, and - FETools::compute_projection_matrices + Changed: The functions FETools::compute_embedding_matrices, + FETools::compute_face_embedding_matrices, and + FETools::compute_projection_matrices (mostly used in internal computations in setting up finite element objects) previously took pointers to the first element of an array of matrices as arguments. This isn't type-safe, and @@ -1484,26 +1381,18 @@ inconvenience this causes.

    49. - Extended: DerivativeApproximation now offers access to the + Extended: DerivativeApproximation now offers access to the full tensor of derivatives of orders one, two and three. This - information can be requested for a single cell by means of the DerivativeApproximation::approximate_derivative_tensor function. If the - norm of this tensor is required later on, the new DerivativeApproximation::derivative_norm function can be used. Note, that + information can be requested for a single cell by means of the DerivativeApproximation::approximate_derivative_tensor function. If the + norm of this tensor is required later on, the new DerivativeApproximation::derivative_norm function can be used. Note, that for second order derivatives, this returns the largest eigenvalue - instead of the Frobenius norm, which is returned by the Tensor<rank_,dim>::norm function. + instead of the Frobenius norm, which is returned by the Tensor<rank_,dim>::norm function.
      (Tobias Leicht 2006/08/03)

    50. - Fixed: DerivativeApproximation offers approximated + Fixed: DerivativeApproximation offers approximated derivatives of a discrete function. The symmetrization of the derivative tensor is now done at the right place, i.e. the derivative itself is symmetrized instead of an intermediate tensor. This should improve the @@ -1514,8 +1403,7 @@ inconvenience this causes.

    51. - Fixed: The DataOut::build_patches and similar + Fixed: The DataOut::build_patches and similar functions in the related DataOut* classes allowed to pass zero as the second argument (denoting the number of threads to use if multithreading is enabled). This led to no output being created at @@ -1525,8 +1413,7 @@ inconvenience this causes.

    52. - New: The new function FiniteElementBase::n_dofs_per_object returns either + New: The new function FiniteElementBase::n_dofs_per_object returns either dofs_per_vertex, dofs_per_line, dofs_per_quad, ..., depending on the explicitly specified function template argument. This is often useful for @@ -1536,8 +1423,7 @@ inconvenience this causes.

    53. - Fixed: Triangulation<dim>::fix_coarsen_flags + Fixed: Triangulation<dim>::fix_coarsen_flags has been modified to allow coarsening in all possible cases. Up to now, coarsening was forbidden, if the neighbor cell was not refined but had the refine_flag set, whereas it was allowed, if @@ -1550,11 +1436,7 @@ inconvenience this causes.

    54. - New: There are now new internal TriaObjectAccessor<1,dim>::lines() and TriaObjectAccessor<2,dim>::quads() functions. By using these + New: There are now new internal TriaObjectAccessor<1,dim>::lines() and TriaObjectAccessor<2,dim>::quads() functions. By using these functions, 30 function specializations could be removed, significantly reducing code duplication.
      @@ -1562,8 +1444,7 @@ inconvenience this causes.

    55. - New: Function VectorTools::create_point_source_vector to calculate the projection + New: Function VectorTools::create_point_source_vector to calculate the projection of a Dirac pulse on the base functions. This models a point source as used in the calculations of Green's functions and can also be used to extract the value of a finite element solution in a single point. @@ -1572,11 +1453,7 @@ inconvenience this causes.

    56. - Changed: Functions VectorTools::point_value and VectorTools::point_difference using the old interface + Changed: Functions VectorTools::point_value and VectorTools::point_difference using the old interface without boundary mapping were replaced by wrapper functions calling the new versions.
      @@ -1584,8 +1461,7 @@ inconvenience this causes.

    57. - Changed: The old version of GridTools::find_active_cell_around_point has been replaced + Changed: The old version of GridTools::find_active_cell_around_point has been replaced by a wrapper function for backward compatibility. The wrapper calls the new version of this function, and it is highly recommended to use the new version as it automatically delivers also the local coordinate of the @@ -1596,11 +1472,8 @@ inconvenience this causes.

    58. - Improved: The functions VectorTools::point_value and VectorTools::point_difference now can also use arbitrary - mappings, using the new GridTools::find_active_cell_around_point algorithm. + Improved: The functions VectorTools::point_value and VectorTools::point_difference now can also use arbitrary + mappings, using the new GridTools::find_active_cell_around_point algorithm.
      (Ralf B. Schulz, 2006/05/11)

      @@ -1634,8 +1507,7 @@ inconvenience this causes. (WB 2006/05/01)

      -
    59. Fixed: second derivatives where not computed correctly in FEFaceValuesBase, i.e. when evaluating +

    60. Fixed: second derivatives where not computed correctly in FEFaceValuesBase, i.e. when evaluating second derivatives on faces of cells. This is now fixed. Using second derivatives evaluated at quadrature points within a cell was not affected by this problem. @@ -1699,8 +1571,7 @@ inconvenience this causes.

    61. - New: There is a new function FiniteElement::face_to_equivalent_cell_index that can + New: There is a new function FiniteElement::face_to_equivalent_cell_index that can convert a face index of a degree of freedom into a corresponding cell index.
      @@ -1708,91 +1579,60 @@ inconvenience this causes.

    62. - New: There are now functions VectorTools::point_value that evaluate the value of a + New: There are now functions VectorTools::point_value that evaluate the value of a finite element function at a given point inside the domain.
      (WB 2006/03/06)

    63. Improved: GridOut now has functions for - declaring and parsing parameters in a ParameterHandler, like used in DataOut_Interface for a long time. + declaring and parsing parameters in a ParameterHandler, like used in DataOut_Interface for a long time.
      (GK 2006/03/06)

    64. - Improved: The Triangulation, PersistentTriangulation, DoFHandler, hp::DoFHandler and MGDoFHandler classes now all have a dimension variable which allows to ask + Improved: The Triangulation, PersistentTriangulation, DoFHandler, hp::DoFHandler and MGDoFHandler classes now all have a dimension variable which allows to ask the template argument dim by - SomeClass::dimension. + SomeClass::dimension.
      (RH 2006/02/27)

    65. - Fixed: When used, the copy constructor of MappingQ would lead to memory + Fixed: When used, the copy constructor of MappingQ would lead to memory corruption. This is now fixed.
      (RH 2006/02/23)

    66. - New: There is now a StaticMappingQ1::mapping object of type MappingQ1 which is used in several parts - of the library. This way multiple creation and storage of MappingQ1 objects can be avoided. + New: There is now a StaticMappingQ1::mapping object of type MappingQ1 which is used in several parts + of the library. This way multiple creation and storage of MappingQ1 objects can be avoided.
      - Similar to StaticMappingQ1::mapping there is now also an object hp::StaticMappingQ1::mapping_collection of type MappingCollection. + Similar to StaticMappingQ1::mapping there is now also an object hp::StaticMappingQ1::mapping_collection of type MappingCollection.
      (RH 2006/02/21)

    67. - New: There is now a GridOut::write_gmsh function to write in the gmsh + New: There is now a GridOut::write_gmsh function to write in the gmsh format. It has the same features of the write_ucd one.
      (Luca Heltai 2006/02/17)

    68. - Changed: The hp::FECollection::get_fe, hp::QCollection::get_quadrature and hp::MappingCollection::get_mapping functions are now renamed to + Changed: The hp::FECollection::get_fe, hp::QCollection::get_quadrature and hp::MappingCollection::get_mapping functions are now renamed to the standard operator[] - function. Similarly, the FECollection::n_finite_elements, QCollection::n_quadratures and MappingCollection::n_mappings functions are now renamed to + function. Similarly, the FECollection::n_finite_elements, QCollection::n_quadratures and MappingCollection::n_mappings functions are now renamed to the standard size() function.
      (RH 2006/02/10)

    69. - Improved: GridGenerator::half_hyper_ball now is implemented also + Improved: GridGenerator::half_hyper_ball now is implemented also in three dimensions, and the boundary now is colored with 0 and one respectively on the curved and plane.
      @@ -1809,9 +1649,7 @@ inconvenience this causes.

    70. - Fixed: The MGDoFHandler::distribute_dofs and renumber functions could not handle + Fixed: The MGDoFHandler::distribute_dofs and renumber functions could not handle coarsened grids (unused vertices, faces and cells). This is now fixed.
      @@ -1836,8 +1674,7 @@ inconvenience this causes.

    71. Improved: A new TriaAccessor::ExcCellHasNoChildren - exception will be raised if the TriaObjectAccessor::child_index function + exception will be raised if the TriaObjectAccessor::child_index function is invoked for cells without children.
      (RH 2005/12/09) @@ -1854,26 +1691,22 @@ inconvenience this causes.

    72. - New: There is now a new Triangulation::get_boundary_indicators + New: There is now a new Triangulation::get_boundary_indicators function.
      (RH 2005/09/30)

    73. - New: There is now a new GridTools::delete_unused_vertices - function. Previously a private function in GridIn it has now been moved to and made + New: There is now a new GridTools::delete_unused_vertices + function. Previously a private function in GridIn it has now been moved to and made public in GridTools.
      (RH 2005/09/28)

    74. - New: The GridIn<dim>::read_netcdf(string + New: The GridIn<dim>::read_netcdf(string &filename) function reads grids from NetCDF files. The only data format currently supported is the TAU grid format. @@ -1882,8 +1715,7 @@ inconvenience this causes.

    75. - Fixed: The GridIn<dim>::read(filename, format) + Fixed: The GridIn<dim>::read(filename, format) function ran into an exception when called with Default format and a filename which does not include /. This is now fixed. diff --git a/examples/step-32/doc/results.dox b/examples/step-32/doc/results.dox index d26392b17d..7538e540f0 100644 --- a/examples/step-32/doc/results.dox +++ b/examples/step-32/doc/results.dox @@ -44,7 +44,7 @@ the default):

      -$ mpirun -n 50 ./step-32
      +\$ mpirun -np 50 ./step-32
       
      diff --git a/examples/step-42/doc/intro.dox b/examples/step-42/doc/intro.dox index 62168896d1..4137876e70 100644 --- a/examples/step-42/doc/intro.dox +++ b/examples/step-42/doc/intro.dox @@ -10,7 +10,6 @@ in the following paper:
      J. Frohne, T. Heister, W. Bangerth: Efficient numerical methods for the large-scale, parallel solution of elastoplastic contact problems. Submitted, 2013. - diff --git a/examples/step-52/step-52.cc b/examples/step-52/step-52.cc index ba3266b27e..8011c4b5fc 100644 --- a/examples/step-52/step-52.cc +++ b/examples/step-52/step-52.cc @@ -335,7 +335,7 @@ namespace Step52 - // @sect5{Diffusion::output_results} + // @sect5{Diffusion::output_results} // // We output the solution in vtu files. void Diffusion::output_results(unsigned int time_step,TimeStepping::runge_kutta_method method) const diff --git a/examples/step-53/step-53.cc b/examples/step-53/step-53.cc index ed19329fa0..d30105ceae 100644 --- a/examples/step-53/step-53.cc +++ b/examples/step-53/step-53.cc @@ -219,8 +219,8 @@ SphereGeometry<3>::average (const std_cxx1x::array (&array)[N]) } // finally for the polar angle. the difficulty here is that we have, for - // example, two points at (r,phi,theta) and (r,phi+pi,\pm pi/2), then we want - // to average these to (r,*,pi) where the equatorial angle does not matter + // example, two points at $(r,\phi,\theta)$ and $(r,\phi+\pi,\pm \pi/2)$, then we want + // to average these to $(r,\ast,\pi)$ where the equatorial angle does not matter { //??? not sure how exactly to do this } diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 5bf78154ba..1638d35b7a 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -748,7 +748,7 @@ namespace DoFTools * grid. The finite element used for the respective components on the two * grids needs to be the same. An example may clarify this: consider an * optimization problem with controls $q$ discretized on a coarse mesh and a - * state variable $u$ (and corresponding Lagrange multiplier $\lambda) + * state variable $u$ (and corresponding Lagrange multiplier $\lambda$) * discretized on the fine mesh. These are discretized using piecewise * constant discontinuous, continuous linear, and continuous linear * elements, respectively. Only the parameter $q$ is represented on the -- 2.39.5