From 62a45cfcd0dbc9666d52af7fab0349ac52f3834a Mon Sep 17 00:00:00 2001 From: wolf Date: Wed, 3 Mar 2004 23:18:16 +0000 Subject: [PATCH] Merge petsc changes into the general document. git-svn-id: https://svn.dealii.org/trunk@8651 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/doc/news/c-4-0.html | 133 +++++++++++++++++++++++--- deal.II/doc/news/c-petsc.html | 170 ---------------------------------- 2 files changed, 120 insertions(+), 183 deletions(-) delete mode 100644 deal.II/doc/news/c-petsc.html diff --git a/deal.II/doc/news/c-4-0.html b/deal.II/doc/news/c-4-0.html index 1ab9ec8ee1..0598f89b88 100644 --- a/deal.II/doc/news/c-4-0.html +++ b/deal.II/doc/news/c-4-0.html @@ -32,6 +32,21 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK

Incompatibilities

    +
  1. Changed: The FiniteElement classes had a + function restrict that returns the + restriction matrix from children to the mother cell. Unfortunately, + restrict has become a keyword in recent standards of the C + language, and some C++ compilers have picked this up. The function has + therefore been renamed get_restriction_matrix, which also better + reflects what it is actually doing. To keep consistent, we have also + rename the corresponding function prolongate to get_prolongation_matrix. +
    + (WB 2004/02/29) +

    +
  2. Fixed and changed: The SolutionTransferGeneral

      +
    1. New: deal.II now comes with a complete set of + wrappers classes for PETSc vectors, matrices, linear solvers and + preconditioners. Many of the algorithms in deal.II have also been + updated to make use of these wrappers. All of this is only enabled if a + PETSc installation is detected. This either happens automatically in + ./configure, or + by passing values to the switches --with-petsc and + --with-petsc-arch to configure path and architecture of an + existing PETSc installation. If these switches are not used, then + environment variables are searched for this information. +
      + (WB 2004/03/01) +

      +
    2. Changed: The part of the boost library in the contrib directory is now updated to boost version 1-30.2. We include @@ -298,6 +327,31 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK

      +
    3. New: The Vector and BlockVector classes now have member functions + is_non_negative that check whether a vector + has no negative entries. +
      + (WB 2004/02/29) +

      + +
    4. Fixed: The SolverMinRes class had a nasty bug where we were + inadvertantly copying vectors; this could also have led to a memory + corruption bug. This is now fixed. +
      + (WB 2004/02/26) +

      + +
    5. New: There is now a function FullMatrix::add_scaled. It replaces the old + function FullMatrix::add which did the same, + but had a name that was incompatible with respective functions in the + other matrix classes. +
      + (WB 2004/02/23) +

      +
    6. New:FullMatrix has new functions add and ,Tadd @@ -305,6 +359,36 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
      (GK 2004/02/12)

      + +
    7. New: The Vector class now has operators to compare for + equality and inequality. +
      + (WB 2004/02/09) +

      + +
    8. New: The SparseMatrix::operator() generated an assertion + failure if the requested entry in the matrix isn't there. This has been + changed so that it actually throws an exception instead, also in + optimized mode. +
      + (WB 2004/02/06) +

      + +
    9. New: There is now a function SparseMatrix::frobenius_norm that computes the + Frobenius norm of a sparse matrix. +
      + (WB 2004/02/06) +

      + +
    10. Changed: In matrix-vector operations of the Full/SparseMatrix classes, source and destination + cannot be the same. We now also check that this is indeed the case. +
      + (WB 2004/01/26) +

    11. Improved: Initialization routines of class SparseMatrix have an additional parameter @@ -361,23 +445,46 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK

      deal.II

        +
      1. Changed: The classes DataOut* and KellyErrorEstimator have been generalized to take + more and different vector types as input parameters. In particular, + they now take normal and block vectors over doubles and floats, as well + as PETSc vectors if PETSc support is detected during configuration of + the library. +
        + (WB 2004/03/01) +

        + +
      2. Changed: The template parameter of the functions in the GridRefinement class have been changed. Where they + previously denoted the type over which the Vector class is to be templated, they now mean the + actual vector class. Thus, they can be any other template class as long + as there are suitable operations defined over them. In addition, + the documentation stated that they must be vectors of floats; this + hasn't been true any more for quite a while already, and is duly + removed from the documentation. +
        + (WB 2004/02/28) +

      3. - New: The function - FETools::project_dg performs - L2-projections between finite element spaces of different - degrees on the same mesh. -
        - (GK 2003/11/28) -

        + New: The function + FETools::project_dg + performs L2-projections between finite element spaces + of different degrees on the same mesh. +
        + (GK 2003/11/28) +

      4. - Improved: FiniteElementData has a function - tensor_degree(), returning the degree of the - polynomial space suitable for choosing a tensor product quadrature formula. -
        - (GK 2003/11/28) -

        + Improved: FiniteElementData has a function + tensor_degree(), returning the degree of the + polynomial space suitable for choosing a tensor product quadrature + formula. +
        + (GK 2003/11/28) +

      5. New: Long requested but never implemented before in the diff --git a/deal.II/doc/news/c-petsc.html b/deal.II/doc/news/c-petsc.html deleted file mode 100644 index a4e2c21b15..0000000000 --- a/deal.II/doc/news/c-petsc.html +++ /dev/null @@ -1,170 +0,0 @@ - - - - - The deal.II news page - - - - - - -

        Changes after Version 4.0

        - -

        -This is the list of changes made after the release of -deal.II version 4.0. It is subdivided into changes -made to the three sub-libraries base, -lac, and deal.II, as well as -changes to the general infrastructure, -documentation, etc. -

        - -

        -All entries are signed with the names of the author. Regular -contributor's names are abbreviated by WB (Wolfgang Bangerth), GK -(Guido Kanschat), RH (Ralf Hartmann). -

        - - - -

        Incompatibilities

        - -
          -
        1. Changed: The FiniteElement classes had a - function restrict that returns the - restriction matrix from children to the mother cell. Unfortunately, - restrict has become a keyword in recent standards of the C - language, and some C++ compilers have picked this up. The function has - therefore been renamed get_restriction_matrix, which also better - reflects what it is actually doing. To keep consistent, we have also - rename the corresponding function prolongate to get_prolongation_matrix. -
          - (WB 2004/01/29) -

          - -
        - - - -

        General

        - -
          -
        1. New: There are now switches --with-petsc and - --with-petsc-arch to configure path and architecture of an - existing PETSc installation. If these switches are not used, then - environment variables are searched for this information. -
          - (WB 2004/01/26) -

          -
        - - - - -

        base

        - -
          -
        - - - - -

        lac

        - -
          -
        1. New: The Vector and BlockVector classes now have member functions - is_non_negative that check whether a vector - has no negative entries. -
          - (WB 2004/02/29) -

          - -
        2. Fixed: The SolverMinRes class had a nasty bug where we were - inadvertantly copying vectors; this could also have led to a memory - corruption bug. This is now fixed. -
          - (WB 2004/02/26) -

          - -
        3. New: There is now a function FullMatrix::add_scaled. It replaces the old - function FullMatrix::add which did the same, - but had a name that was incompatible with respective functions in the - other matrix classes. -
          - (WB 2004/02/23) -

          - -
        4. New: The Vector class now has operators to compare for - equality and inequality. -
          - (WB 2004/02/09) -

          - -
        5. New: The SparseMatrix::operator() generated an assertion - failure if the requested entry in the matrix isn't there. This has been - changed so that it actually throws an exception instead, also in - optimized mode. -
          - (WB 2004/02/06) -

          - -
        6. New: There is now a function SparseMatrix::frobenius_norm that computes the - Frobenius norm of a sparse matrix. -
          - (WB 2004/02/06) -

          - -
        7. Changed: In matrix-vector operations of the Full/SparseMatrix classes, source and destination - cannot be the same. We now also check that this is indeed the case. -
          - (WB 2004/01/26) -

          -
        - - - - -

        deal.II

        - -
          -
        1. Changed: The classes DataOut* and KellyErrorEstimator have been generalized to take - more and different vector types as input parameters. In particular, - they now take normal and block vectors over doubles and floats, as well - as PETSc vectors if PETSc support is detected during configuration of - the library. -
          - (WB 2004/03/01) -

          - -
        2. Changed: The template parameter of the functions in the GridRefinement class have been changed. Where they - previously denoted the type over which the Vector class is to be templated, they now mean the - actual vector class. Thus, they can be any other template class as long - as there are suitable operations defined over them. In addition, - the documentation stated that they must be vectors of floats; this - hasn't been true any more for quite a while already, and is duly - removed from the documentation. -
          - (WB 2004/02/28) -

          -
        - -
        -Last update $Date$ - - - -- 2.39.5