From: Wolfgang Bangerth Date: Fri, 25 Jun 2010 18:33:03 +0000 (+0000) Subject: Do not have dots in doxygen page names. X-Git-Tag: v8.0.0~5915 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e7393d8459311bf4460f465d8d9c9dc63bea3c6f;p=dealii.git Do not have dots in doxygen page names. git-svn-id: https://svn.dealii.org/trunk@21367 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/doc/news/6.0.0-vs-6.1.0.h b/deal.II/doc/news/6.0.0-vs-6.1.0.h index d827564b7c..7871cad9df 100644 --- a/deal.II/doc/news/6.0.0-vs-6.1.0.h +++ b/deal.II/doc/news/6.0.0-vs-6.1.0.h @@ -1,10 +1,10 @@ /** - * @page changes_between_6.0_and_6.1 Changes between Version 6.0 and 6.1 + * @page changes_between_6_0_and_6_1 Changes between Version 6.0 and 6.1

-This is the list of changes made between the release of +This is the list of changes made between the release of deal.II version 6.0 and version 6.1. It is subdivided into changes -made to the three sub-libraries base, +made to the three sub-libraries base, lac, and deal.II, as well as changes to the general infrastructure, documentation, etc. @@ -87,7 +87,7 @@ inconvenience this causes.

  • Changed: The deprecated typedefs - internal::Triangulation::Line, + internal::Triangulation::Line, internal::Triangulation::Quad, and internal::Triangulation::Hexahedron have been removed.
    @@ -122,12 +122,12 @@ inconvenience this causes. incompressible fluid flow.
    (WB, 2008/03/28) -

    +

  • New: step-29 demonstrates how problems involving complex %numbers can be implemented by viewing real and imaginary parts of a complex-valued solution as the two components of a vector-valued - function. + function.
    (Moritz Allmaras, 2007/10/31)

    @@ -169,7 +169,7 @@ default names for variables in the given space dimension. For example, in

  • New: ConvergenceTable::evaluate_convergence_rates has been incomplete -for a long time. An implementation for reduction_rate and +for a long time. An implementation for reduction_rate and reduction_rate_log2 has been added in the case where one specifies a reference column that allows to compute error rates also for local refinement. @@ -178,7 +178,7 @@ refinement.

  • Fixed: The Utilities::int_to_string function did not work for 5 or 6 -digits, while its counterpart Utilities::needed_digits does. This is now fixed, +digits, while its counterpart Utilities::needed_digits does. This is now fixed, and the two are coherent.
    (Luca Heltai 2008/04/16) @@ -191,7 +191,7 @@ an object from an array consisting its independent components.

  • New: There are now output operators (i.e. operator@<@<) -for the SymmetricTensor class. +for the SymmetricTensor class.
    (WB 2008/02/12)

  • @@ -241,7 +241,7 @@ an integer id of the current thread. intermediate format writer make use of it.

    The use of this ability is explained in the step-22 and - step-33 tutorial programs. + step-33 tutorial programs.
    (WB 2007/10/11)

    @@ -260,9 +260,9 @@ an integer id of the current thread.

    lac

      -
    1. Changed: A few simple PETSc wrappers for helper functions - PETScWrappers::MatrixBase::transpose, - PETScWrappers::MatrixBase::is_symmetric, +

    2. Changed: A few simple PETSc wrappers for helper functions + PETScWrappers::MatrixBase::transpose, + PETScWrappers::MatrixBase::is_symmetric, PETScWrappers::MatrixBase::is_hermitian, and PETScWrappers::MatrixBase::write_ascii have been added.
      @@ -353,7 +353,7 @@ constraints individually.

    3. Fixed: Functions::FEFieldFunction.set_active_cell was declared - inline in the declaration but not in the implementation. This is now fixed. + inline in the declaration but not in the implementation. This is now fixed.
      (Luca Heltai 2008/04/16)

    4. @@ -525,7 +525,7 @@ constraints individually. GridIn functions, would not yield the same mesh upon refinement.
      - (Luca Heltai 2007/09/10) + (Luca Heltai 2007/09/10)

      @@ -539,8 +539,8 @@ constraints individually. calculation of new data based on the values and possibly derivatives of the original data at each point of the patch.
      - (Tobias Leicht 2007/09/10) -

      + (Tobias Leicht 2007/09/10) +

    diff --git a/deal.II/doc/news/6.1.0-vs-6.2.0.h b/deal.II/doc/news/6.1.0-vs-6.2.0.h index 64a215ea3e..c99210b27f 100644 --- a/deal.II/doc/news/6.1.0-vs-6.2.0.h +++ b/deal.II/doc/news/6.1.0-vs-6.2.0.h @@ -1,10 +1,10 @@ /** - * @page changes_between_6.1_and_6.2 Changes between Version 6.1 and 6.2 + * @page changes_between_6_1_and_6_2 Changes between Version 6.1 and 6.2

    -This is the list of changes made between the release of +This is the list of changes made between the release of deal.II version 6.1 and version 6.2. It is subdivided into changes -made to the three sub-libraries base, +made to the three sub-libraries base, lac, and deal.II, as well as changes to the general infrastructure, documentation, etc. @@ -31,9 +31,9 @@ inconvenience this causes.

    1. -

      +

      Changed: The implementation of the reordering algorithms in the boost - namespace created multiple edges between two nodes. The new implementation + namespace created multiple edges between two nodes. The new implementation submits not more than one edge, but that affects the ordering of the degrees of freedom and deviates from previous behavior.
      @@ -41,7 +41,7 @@ inconvenience this causes.

    2. -

      +

      Changed: The files implementing the class ConstraintMatrix are now saved in the lac/ subdirectory, named constraint_matrix.h and included by the line \#include @@ -57,7 +57,7 @@ inconvenience this causes.

    3. -

      +

      Changed: The function DoFTools::get_subdomain_association function used to assign degrees of freedom to the subdomain of the last cell on which the degree of freedom is a part. This introduced a bias for degrees of @@ -72,12 +72,12 @@ inconvenience this causes.

    4. -

      +

      Changed: The way we set up threads in the Threads::spawn functions and friends has been completely written, using the boost::bind and boost::function libraries. This has made things significantly simpler and allowed us to remove some 4,100 lines of code. The only - user-visible side effect is that you can now no longer spawn + user-visible side effect is that you can now no longer spawn functions with 10 arguments (this was the maximum before) whereas 9 arguments continues to work; the reason for this is a limitation in the boost::bind library. This limit will be lifted with the next @@ -87,7 +87,7 @@ inconvenience this causes.

    5. -

      +

      Changed: The SolutionTransfer class used to take a type as second template argument that denoted the scalar upon which Vector objects were built, in order to allow interpolating Vector@ objects, @@ -103,7 +103,7 @@ inconvenience this causes.

    6. -

      +

      Changed: The FiniteElement::get_prolongation_matrix and FiniteElement::get_restriction_matrix functions now have an additional argument of type RefinementCase to enable a @@ -115,7 +115,7 @@ inconvenience this causes.
      (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/07/04)

      - +
    7. Changed: GeometryInfo::children_per_cell has been @@ -148,7 +148,7 @@ inconvenience this causes.
      (RH 2008/07/08 as of branch_anisotropic at 2005/02/26)

      - +
    8. Changed: The GeometryInfo::child_cell_on_face function is @@ -170,9 +170,9 @@ inconvenience this causes.

      1. - Updated: The step-22 tutorial program now uses some - advanced features of the ConstraintMatrix such as imhomogeneities - for implementing Dirichlet boundary condition and condensation of + Updated: The step-22 tutorial program now uses some + advanced features of the ConstraintMatrix such as imhomogeneities + for implementing Dirichlet boundary condition and condensation of constraints on the fly.
        (Martin Kronbichler 2009/04/20) @@ -191,7 +191,7 @@ inconvenience this causes.

      2. - Updated: Configure mechanism and a few PETSc functions in the lac directory + Updated: Configure mechanism and a few PETSc functions in the lac directory have been upgraded to support migration to PETSc version >=3.0.0 in anaology to the existing interface.
        @@ -200,9 +200,9 @@ inconvenience this causes.

      3. - New: A new tutorial program step-34 was added to the + New: A new tutorial program step-34 was added to the library that shows the usage of the new codimension one functionality - recently added to the library. In this tutorial we show the use of + recently added to the library. In this tutorial we show the use of bondary element methods on piecewise constant functions defined over a surface, and we solve the irrotational flow problem, or exterior Neumann Laplace problem. @@ -224,7 +224,7 @@ inconvenience this causes.

        Changed: The subversion repository for deal.II development is now located on commercially hosted space at http://www.dealii.org/svn/dealii/. + href="http://www.dealii.org/svn/dealii/">http://www.dealii.org/svn/dealii/.
        (GK 2009/01/20)

        @@ -249,7 +249,7 @@ inconvenience this causes.
      4. Updated: The step-33 tutorial program now uses the - Trilinos wrapper + Trilinos wrapper classes for accessing Trilinos linear algebra routines instead of implementing that by hand.
        @@ -300,7 +300,7 @@ inconvenience this causes.

      5. -

        +

        Changed: The various accessor classes have been rewritten entirely. Where previously we had these accessor classes as separate specializations for 1d, 2d, and 3d, each implementing the same @@ -312,18 +312,18 @@ inconvenience this causes.
        (WB 2008/12/05)

        - +
      6. -

        +

        New: In analogy to the existing interfaces to the PETSc library, there are now also interfaces to much of the linear algebra part of the Trilinos library.
        (Martin Kronbichler 2008/12/01)

        - +
      7. -

        +

        New: The deal.II configure script now autodetects SLEPc, an eigenvalue solver. Currently on SLEPc versions >=3.0.0 are supported.
        @@ -344,14 +344,14 @@ inconvenience this causes.

      8. Updated: In the step-22 tutorial program the generation of - the sparsity pattern using the class BlockCompressedSetSparsityPattern has - been replaced by a pattern of the class BlockCompressedSimpleSparsityPattern, + the sparsity pattern using the class BlockCompressedSetSparsityPattern has + been replaced by a pattern of the class BlockCompressedSimpleSparsityPattern, which uses far less memory and is slightly faster.
        (Martin Kronbichler, WB 2008/11/12)

      9. - +
      10. New: The shared libraries we create are now versioned, i.e. they have @@ -448,17 +448,17 @@ inconvenience this causes. New: There is now a new QGaussOneOverR class, that allows for integration on the two dimensional reference element of arbitrary polynomial functions with weight 1/R. This class is only instantiated for dim=2, and it is intended - for use with collocation type boundary element methods of order 1, where the - singularities are collocated on the vertices of the quadrilaterals. -
        + for use with collocation type boundary element methods of order 1, where the + singularities are collocated on the vertices of the quadrilaterals. +
        (Luca Heltai 2009/03/11)

      11. - New: There is now a new QGaussLogR class, that generalizes the QGaussLog class to + New: There is now a new QGaussLogR class, that generalizes the QGaussLog class to allow for arbitrary location of singularities, and singularity factors. -
        +
        (Luca Heltai 2009/03/11)

        @@ -467,7 +467,7 @@ inconvenience this causes. New: The FunctionParser class now supports the fparser library's interface to use units (like cm, or km) in expressions. An example is given in the documentation of that class. -
        +
        (Victor Prosolin 2009/03/01)

        @@ -476,24 +476,24 @@ inconvenience this causes. Changed: The classes Threads::ThreadMutex and Threads::ThreadCondition have been renamed Threads::Mutex and Threads::ConditionVariable. The old names were somewhat redundant but have been retained as typedefs for compatibility. -
        +
        (WB 2009/01/14)

        - +
      12. New: There is now a class TimerOutput that allows to neatly measure computing times in different sections of a program and write that information to screen. -
        +
        (Martin Kronbichler 2009/01/12)

      13. - New: The Timer class can now also return the wall time using the method - Timer::wall_time(), as opposed to the CPU time returned by + New: The Timer class can now also return the wall time using the method + Timer::wall_time(), as opposed to the CPU time returned by Timer::operator (). -
        +
        (Martin Kronbichler 2009/01/07)

        @@ -503,7 +503,7 @@ inconvenience this causes. efficient by allowing to figure out whether certain template types are, for example, equal to double or float (in which case we can use BLAS functions, or could do something else special). -
        +
        (WB 2008/10/31)

        @@ -511,7 +511,7 @@ inconvenience this causes.

        New: The Utilities::reverse_permutation and Utilities::invert_permutation compute the reverse and inverse of a given permutation of indices. -
        +
        (WB 2008/10/31)

        @@ -520,7 +520,7 @@ inconvenience this causes. Fixed: The PolynomialsRaviartThomas class had a bug that led to random results when used from multiple threads. As a consequence the FE_RaviartThomas class was unusable in a multithreaded context. This has now been fixed. -
        +
        (WB 2008/10/13)

        @@ -529,7 +529,7 @@ inconvenience this causes. New: There is a new function scalar_product(const Tensor<2,dim> &, const Tensor<2,dim> &) that computes the scalar product $a:b=\sum_{i,j} a_{ij}b_{ij}$ between two tensors of rank 2. -
        +
        (WB 2008/08/15)

        @@ -540,7 +540,7 @@ inconvenience this causes. base/include/base/config.h. This also fixes a problem in base/include/base/utilities.h if a compiler capable of including mpi.h was used but not PETSc. -
        +
        (WB 2008/08/15)

        @@ -549,7 +549,7 @@ inconvenience this causes. Fixed: A misplaced \#include directive prevented the file base/source/data_out_base.cc from being compilable by the PGI C++ compiler. This is now fixed. -
        +
        (WB 2008/08/05)

        @@ -565,7 +565,7 @@ inconvenience this causes. (line 0) shall be refined. Another refinement possibility for the cell would be RefinementCase::cut_xy, but that is not the minimal case. -
        +
        (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/28)

        @@ -575,7 +575,7 @@ inconvenience this causes. function which returns the RefinementCase representing the refinement case of a line for a given refinement case of the corresponding cell. -
        +
        (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/28)

        @@ -585,7 +585,7 @@ inconvenience this causes. GeometryInfo::n_children(refinement_case) function returns the number of children a cell/face has when refined with the RefinementCase refinement_case. -
        +
        (RH 2008/07/08 as of branch_anisotropic at 2005/11/07)

        @@ -607,7 +607,7 @@ inconvenience this causes. GeometryInfo<2>::isotropic_refinement=RefinementCase::cut_xy and GeometryInfo<3>::isotropic_refinement=RefinementCase::cut_xyz. -
        +
        (RH 2008/07/08 as of branch_anisotropic at 2005/03/03)

        @@ -615,7 +615,7 @@ inconvenience this causes.

        New: The class QGaussLog allows the quadrature of integrals with logarithmic kernels. -
        +
        (Cataldo Manigrasso 2008/05/28)

        @@ -629,9 +629,9 @@ inconvenience this causes.
        1. - Updated: The SparseMatrix::precondition_SSOR function was implemented - inefficiently. The new implementation uses about half the instruction - count and reduces execution times on typical applications by ten to + Updated: The SparseMatrix::precondition_SSOR function was implemented + inefficiently. The new implementation uses about half the instruction + count and reduces execution times on typical applications by ten to thirty percent.
          (Martin Kronbichler 2009/04/21) @@ -639,7 +639,7 @@ inconvenience this causes.

        2. - Updated: The SparseILU::vmult kernel has been re-written to use similar + Updated: The SparseILU::vmult kernel has been re-written to use similar data structures as SparseMatrix::vmult, which reduces the count of operations by one third and the execution times on typical applications by ten to twenty percent. @@ -650,12 +650,12 @@ inconvenience this causes.

        3. New: There is now a new class VectorView that allows views of - arbitrary areas of memory to be seen as a Vector, simplifying - a lot of works for portability issues between different libraries, and - allowing for subviews of Vector classes without the need to + arbitrary areas of memory to be seen as a Vector, simplifying + a lot of works for portability issues between different libraries, and + allowing for subviews of Vector classes without the need to copy back and forth large chunk of memories.
          - To be used with EXTREME caution, and only when you know exactly what you + To be used with EXTREME caution, and only when you know exactly what you are doing, and speed is a necessity.
          (Luca Heltai 2009/04/05) @@ -664,7 +664,7 @@ inconvenience this causes.

        4. Updated: The local_to_global functions in ConstraintMatrix got smarter, - which accelerates sparsity pattern generation and makes writing into + which accelerates sparsity pattern generation and makes writing into sparse matrices using distribute_local_to_global faster.
          (Martin Kronbichler 2009/03/16) @@ -681,8 +681,8 @@ inconvenience this causes.

        5. - New: Added a few simple helper functions (to VectorBase) that allow - some manipulation of PETSc vectors. These functions do what they say + New: Added a few simple helper functions (to VectorBase) that allow + some manipulation of PETSc vectors. These functions do what they say in the documentation.
          (Toby D. Young 2009/01/08) @@ -690,10 +690,10 @@ inconvenience this causes.

        6. - New: There is now a class TrilinosWrappers::SparsityPattern that allows to - construct distributed sparsity patterns that can be used for initializing - Trilinos sparse matrices. This means that for large problems on several - MPI processors the memory requirements are reduced and the initialization + New: There is now a class TrilinosWrappers::SparsityPattern that allows to + construct distributed sparsity patterns that can be used for initializing + Trilinos sparse matrices. This means that for large problems on several + MPI processors the memory requirements are reduced and the initialization speed is increased.
          (Martin Kronbichler 2008/12/29) @@ -712,8 +712,8 @@ inconvenience this causes.

        7. - New: The class LAPACKFullMatrix can now invert full matrices using - the (optimized) LAPACK functions getrf and getri. The speedup over + New: The class LAPACKFullMatrix can now invert full matrices using + the (optimized) LAPACK functions getrf and getri. The speedup over the FullMatrix::gauss_jordan() function is a factor of two for matrices with 100 rows and columns, and grows with matrix size.
          @@ -766,8 +766,8 @@ inconvenience this causes.

        8. - Changed: The SparseDirectUMFPACK class now calls the umfpack_dl_* routines - instead of umfpack_di_*. On machines with 64-bit longs this allows the + Changed: The SparseDirectUMFPACK class now calls the umfpack_dl_* routines + instead of umfpack_di_*. On machines with 64-bit longs this allows the UMFPACK solver to allocate more than 2GB of memory for large problems.
          (Moritz Allmaras 2008/10/16) @@ -786,7 +786,7 @@ inconvenience this causes.

        9. - New: Added the CompressedSimpleSparsityPattern as an alternative to + New: Added the CompressedSimpleSparsityPattern as an alternative to CompressedSparsityPattern and CompressedSetSparsityPattern, which should be faster in most cases but its memory usage is somewhere inbetween. @@ -822,7 +822,7 @@ inconvenience this causes.

          -
        10. New: Added two new functions to calculate the left or the right inverse of a given +
        11. New: Added two new functions to calculate the left or the right inverse of a given rectangular matrix (FullMatrix::left_invert, FullMatrix::right_invert). They throw an exception if the matrices are not invertible.
          @@ -845,14 +845,14 @@ inconvenience this causes.
          1. - Fixed: VectorTools::integrate_difference now works also on codimension one grids. + Fixed: VectorTools::integrate_difference now works also on codimension one grids.
            (Luca Heltai 2009/04/10)

          2. - Changed: The ConstraintMatrix class can now also handle inhomogeneous + Changed: The ConstraintMatrix class can now also handle inhomogeneous constraints. This means that e.g. Dirichlet boundary conditions are now a special case of algebraic constraints. There are new condense functions that simultaneously act on matrices and vectors for use of this feature. @@ -931,7 +931,7 @@ inconvenience this causes.

          3. New: FEValues objects can now directly calculate the Laplacians of - solution functions at quadrature points. This is equivalent to the + solution functions at quadrature points. This is equivalent to the trace of the Hessians, but faster and more convenient in user code. step-31 program has also been updated to use this.
            @@ -971,7 +971,7 @@ inconvenience this causes.

          4. Upgraded: The FunctionParser classes now use version 2.83 of the fparser - library. + library.
            (Luca Heltai 2008/12/08)

            @@ -990,7 +990,7 @@ inconvenience this causes.

            New: The function DoFTools::make_zero_boundary_constraints() computes the constraints that result from requiring the degrees of freedom at the - boundary to be zero. Use cases are when the sparsity pattern is not known + boundary to be zero. Use cases are when the sparsity pattern is not known / not wanted / not inaccessible.
            (Toby D. Young 2008/12/04) @@ -1043,7 +1043,7 @@ inconvenience this causes. New: When calling function DoFTools::make_sparsity_pattern with a ConstraintMatrix, it is now possible to set a bool argument keep_constrained_dofs. When this flag is set to false, constrained rows and columns will not be part of the sparsity pattern, which increases the performance of matrix operations and decrease memory consumption in case there are many constraints.
            (Martin Kronbichler 2008/10/21) -

            +

          5. @@ -1053,7 +1053,7 @@ inconvenience this causes. function is needed when splitting block matrices in parallel computations.
            (WB 2008/10/07) -

            +

          6. @@ -1069,7 +1069,7 @@ inconvenience this causes. here.
            (WB 2008/10/07) -

            +

          7. @@ -1082,11 +1082,11 @@ inconvenience this causes.

          8. - New: The class FE_Q can now alternatively be constructed based on + New: The class FE_Q can now alternatively be constructed based on support points from a given one-dimensional quadrature rule.
            (Katharina Kormann, Martin Kronbichler, 2008/09/07) -

            +

          9. @@ -1106,7 +1106,7 @@ inconvenience this causes.
            (Martin Kronbichler 2008/08/13)

            - +
          10. New: There is a second GridTools::partition_triangulation @@ -1119,9 +1119,9 @@ inconvenience this causes.

          11. - Fixed: GridTools::find_cells_adjacent_to_vertex had a bug that - prevented its correct functioning in three dimensions. Some - cases were left out due to uncorrect assumptions on the various + Fixed: GridTools::find_cells_adjacent_to_vertex had a bug that + prevented its correct functioning in three dimensions. Some + cases were left out due to uncorrect assumptions on the various refinement possibilities.
            (Luca Heltai 2008/07/17) @@ -1154,7 +1154,7 @@ inconvenience this causes. need to use this function in user_codes. Calling Triangulation::execute_coarsening_and_refinement will be all you need. -
            +
            (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/29)

            @@ -1165,12 +1165,12 @@ inconvenience this causes. depending on the refinement situation of all a cells neighbors, if the cell may be coarsened, in which case the bool value true is returned. This is a functionality which is partly dimension dependend. -
            +
            However, there should never be any reason to use this function in user codes. -
            +
            (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/28)

            - +
          12. New: There is now a new CellAccessor::neighbor_is_coarser function, @@ -1184,7 +1184,7 @@ inconvenience this causes. refinement, where the level of the cell and its neighbor is all the information needed. In case of aniostropic refinement, this new function can be used. -
            +
            (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/28)

            @@ -1211,15 +1211,15 @@ inconvenience this causes. Note, that for reasons of backwards compatibility this flag is NOT included in the general MeshSmoothing::maximum_smoothing flag. -
            +
            (Tobias Leicht 2008/07/08 as of branch_anisotropic at 2006/06/28)

            - +
          13. New: There is now a new TriaObjectAccessor::clear_refinement_case function. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/12/19)

            @@ -1227,7 +1227,7 @@ inconvenience this causes.

            Extended: The CellAccessor::neighbor_of_neighbor function is now extended to anisotropic refinement. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/12/15)

            @@ -1241,7 +1241,7 @@ inconvenience this causes. parameter which allows to create new single as well as pairs for lines n_consecutive_lines=1 or n_consecutive_lines=2, respectively. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/12/15)

            @@ -1260,10 +1260,10 @@ inconvenience this causes. index shall be set. This function can only be called for even numbered children. The same applies to the respective function for faces. -
            +
            Finally, we note that these functions are for internal use, only. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/03/03)

            @@ -1294,7 +1294,7 @@ inconvenience this causes. geometry_info.h, which allows to describe all possible (anisotropic and isotropic) refinement cases in (1,) 2 and 3 dimensions. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/02/26)

            @@ -1303,7 +1303,7 @@ inconvenience this causes. New: There is now a new TriaObjectAccessor::n_children function which returns the number of children of the cell or face it was invoked for. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/02/26)

            @@ -1312,7 +1312,7 @@ inconvenience this causes. New: There is now a new TriaObjectAccessor::refinement_case function which returns the RefinementCase a cell or face is refined with. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/02/26)

            @@ -1340,7 +1340,7 @@ inconvenience this causes. efficiency (but with a penalty on run-time) they might be replaced by vector@ @> (dim, vector@ (n_quads/n_hexes)), later. -
            +
            (RH 2008/07/08 as of branch_anisotropic at 2005/02/26)

            diff --git a/deal.II/doc/news/6.2.0-vs-6.2.1.h b/deal.II/doc/news/6.2.0-vs-6.2.1.h index cf2a70ca33..8d58085911 100644 --- a/deal.II/doc/news/6.2.0-vs-6.2.1.h +++ b/deal.II/doc/news/6.2.0-vs-6.2.1.h @@ -1,8 +1,8 @@ /** - * @page changes_between_6.2.0_and_6.2.1 Changes between Version 6.2.0 and 6.2.1 + * @page changes_between_6_2_0_and_6_2_1 Changes between Version 6.2.0 and 6.2.1

            -This is the list of changes made between the release of +This is the list of changes made between the release of deal.II version 6.2.0 and version 6.2.1:

            diff --git a/deal.II/doc/news/6.2.0-vs-6.3.0.h b/deal.II/doc/news/6.2.0-vs-6.3.0.h index 1ebe468c1b..bb8d652977 100644 --- a/deal.II/doc/news/6.2.0-vs-6.3.0.h +++ b/deal.II/doc/news/6.2.0-vs-6.3.0.h @@ -1,5 +1,5 @@ /** - * @page changes_between_6.2_and_6.3 Changes between Version 6.2 and 6.3 + * @page changes_between_6_2_and_6_3 Changes between Version 6.2 and 6.3

            This is the list of changes made between the release of diff --git a/deal.II/doc/news/changes.h b/deal.II/doc/news/changes.h index 1e4ce11136..0e700e21a2 100644 --- a/deal.II/doc/news/changes.h +++ b/deal.II/doc/news/changes.h @@ -1,5 +1,5 @@ /** - * @page changes_after_6.3 Changes after Version 6.3 + * @page changes_after_6_3 Changes after Version 6.3

            This is the list of changes made after the release of diff --git a/deal.II/doc/news/news.html b/deal.II/doc/news/news.html index 3ef79fe990..f4d1e43425 100644 --- a/deal.II/doc/news/news.html +++ b/deal.II/doc/news/news.html @@ -29,7 +29,7 @@

            Changes in the library since the last release are - here.

            + here.

            @@ -41,7 +41,7 @@ for assembling linear systems by just providing the local integrals. A complete list of changes between versions 6.2.0 and 6.3.0 can be found here. + href="../doxygen/deal.II/changes_between_6_2_and_6_3.html" target="body">here.
            @@ -124,7 +124,7 @@ formulas. Release 6.2.1 corrects these mistakes. A complete list of changes between versions 6.2.0 and 6.2.1 can be found here. + href="../doxygen/deal.II/changes_between_6_2_0_and_6_2_1.html" target="body">here.
            @@ -134,7 +134,7 @@ Version 6.2.0 was released today! A complete list of changes between versions 6.1.0 and 6.2.0 can be found here. + href="../doxygen/deal.II/changes_between_6_1_and_6_2.html" target="body">here.
            @@ -212,7 +212,7 @@ Version 6.1.0 was released today! A complete list of changes between versions 6.0.0 and 6.1.0 can be found here. + href="../doxygen/deal.II/changes_between_6_0_and_6_1.html" target="body">here.