From: Wolfgang Bangerth
+This is the list of changes made between the deal.II releases listed above.
+
+After the old scheme to implement multithreading in
+deal.II has proven to be too difficult, we
+implemented something that is significantly more complex, but at the
+same time significantly simpler to use. There is also a report on this
+subject, explaining why's and how's, which can be accessed from the
+documentation
+page.
+
Version 3.0 of the deal.II object-oriented finite element library is
@@ -76,6 +80,4 @@ The library is written for research purposes and offers many features:
Wolfgang Bangerth, Guido Kanschat, the deal.II team
-After the old scheme to implement multithreading in
-deal.II has proven to be too difficult, we
-implemented something that is significantly more complex, but at the
-same time significantly simpler to use. There is also a report on this
-subject, explaining why's and how's, which can be accessed from the
-documentation
-page.
-
-Version 3.0.1 of the deal.II object-oriented finite element library is
-available on the deal.II home-page at
-
- Version 3.0.1 is a bug fix release of deal.II 3.0. Overall, the
- number of bugs that have been found is very small (only six) and
- have all been fixed (see
- this list). We
- consider this a good sign for pre-release testing.
- By issuing this release, we would now like to close the 3.0.x
- branch. Future work will be on the next major version.
-
-Wolfgang Bangerth, Guido Kanschat, the deal.II team
-
- The only is change is that the configuration detects the
- presence of gcc3.0 and works around a bug in it by compiling
- the file
- Fixed: In 3d, the function
- Fixed:
+This is the list of changes made between the deal.II releases listed above.
+All entries are signed with the names of the author.
+
Changed:
- Changed
Changed:
Implemented a couple of small modifications to get a first 1D
- hp-example running. The
- Changed: Introduced the
- Changed: The
- Changed: The
- Changed: Many of the functions in
- Changed: The
Changed: There are now overloaded versions of the
Changed: The
- Changed: The
+This is the list of changes made between the deal.II releases listed above.
+All entries are signed with the names of the author.
+
@@ -23,22 +33,22 @@
Fix: getting the support points from system finite elements
- (class
- Fix:
Fix: slight bug in
-
Fix:
-
+This is the list of changes made between the deal.II releases listed above.
+All entries are signed with the names of the author.
+
New: Major and minor version numbers of the
- deal.II library are now passed to the
+ deal.II library are now passed to the
compiler as preprocessor variables
New: the
- Changed: deal.II now uses the
+ Changed: deal.II now uses the
New multithreading scheme
+
+Announcement of deal.II 3.0
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2013, 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+/**
+ * @page changes_between_2_0_and_3_0 Changes between Version 2.0 and 3.0
New multithreading scheme
-
-Announcement of deal.II 3.0.1
-
-Changes between versions 3.1.1 and 3.1.2
-
-
-
-
-
-tria_accessor.cc(3d)
without optimization
- flags even for optimized libraries. The gcc bug is documented
- at the gcc bug tracking system page, as bugs reports c++/615 and
- optimization/2938.
-
- (WB 2001/06/27)
-
-
-
-
-
diff --git a/doc/news/2002/3.3.0-vs-3.3.1.html b/doc/news/2002/3.3.0-vs-3.3.1.html
deleted file mode 100644
index c921a59d18..0000000000
--- a/doc/news/2002/3.3.0-vs-3.3.1.html
+++ /dev/null
@@ -1,38 +0,0 @@
-
-
-
-
- Changes between versions 3.3.0 and 3.3.1
-
-
-
-
-DoFTools::make_hanging_node_constraints
- contained an assertion that failed erroneously for finite
- elements that do not have degrees of freedom on vertices. This
- is now fixed.
-
- (WB 2002/02/21)
- TriaAccessor<3,3>::measure
- sometimes computed a negative value. This is now fixed.
-
- (WB 2002/02/21)
-
-Last update $Date$
-
-
-
diff --git a/doc/news/2003/hp.html b/doc/news/2003/hp.html
index 0f99beab58..9da6ce0841 100644
--- a/doc/news/2003/hp.html
+++ b/doc/news/2003/hp.html
@@ -1,13 +1,27 @@
-
-
-
-
- Changes on the hp branch
@@ -32,11 +46,11 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FE
to
- FECollection
at several places and
+ Changed FE
to
+ FECollection
at several places and
also changed depending functions accordingly. Modified the
- reserve_space
method of
- hpDoFHandler
to work for 2D
+ reserve_space
method of
+ hpDoFHandler
to work for 2D
DG-problems. In this context the 2D code for
pre_refinement_notification
was
added as well.
@@ -47,85 +61,85 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Triangulation
+ hp-example running. The Triangulation
class was extended by a method to add
- RefinementListener
s, which allow
+ RefinementListener
s, which allow
other classes to be informed about Refinements. This is
- needed for the hpDoFHandler
, which
- administrates the active_fe_indices
- in the hpDoFLevel
s. Once this
+ needed for the hpDoFHandler
, which
+ administrates the active_fe_indices
+ in the hpDoFLevel
s. Once this
was implemented, the other changes were straightforward. For
1D, the only thing which had to be changed for hp was the
- reserve_space
method.
+ reserve_space
method.
Last but not least, for the hp-example the
- add
method was added to the
- FECollection
. It allows the user to
- add new FiniteElements
s to the
- the FECollection
.
+ add
method was added to the
+ FECollection
. It allows the user to
+ add new FiniteElements
s to the
+ the FECollection
.
(Oliver Kayser-Herold 2003/06/01)
DoFHandler
- as template parameter in classes DataOutStack
,
- DataOutFaces
, DataOut
and
- DataOut_DoFData
.
- DoFHandler
is used as default
+ Changed: Introduced the DoFHandler
+ as template parameter in classes DataOutStack
,
+ DataOutFaces
, DataOut
and
+ DataOut_DoFData
.
+ DoFHandler
is used as default
template argument to ensure backward compatibility. Added
- an overloaded method reinit
for the
- new hpDoFHandler
in class
- FEValues
. Modified method
- interpolate_boundary_values
in
- class VectorTools
to take the
- DoFHandler
as template
+ an overloaded method reinit
for the
+ new hpDoFHandler
in class
+ FEValues
. Modified method
+ interpolate_boundary_values
in
+ class VectorTools
to take the
+ DoFHandler
as template
argument. Probably this method must be changed later, when the real
- hpDoFHandler
is implemented. Added
+ hpDoFHandler
is implemented. Added
the first implementation of the
- hpDoFHandler
which is simply a copy
+ hpDoFHandler
which is simply a copy
of the old one. But it should provide a good basis for the new
- one. Finally the DoFAccessor
is now
+ one. Finally the DoFAccessor
is now
instantiated for the new
- hpDoFAccessor
. Overall these changes
+ hpDoFAccessor
. Overall these changes
now allow the compilation of some of the sample programs with
- the new hpDoFAccessor
but obviously
+ the new hpDoFAccessor
but obviously
not yet with new functionality.
(Oliver Kayser-Herold 2003/02/18)
DoFHandler::n_boundary_dofs
+ Changed: The DoFHandler::n_boundary_dofs
functions have been moved and renamed. They are now
- DoFTools::count_boundary_dofs
.
+ DoFTools::count_boundary_dofs
.
(WB 2003/02/18)
DoFLevel
classes has been moved to
- a namespace internal
, since they are not
+ Changed: The DoFLevel
classes has been moved to
+ a namespace internal
, since they are not
meant for public use.
(WB 2003/02/18)
DoFTools
- are now templatized to accept both DoFHandler
- and hpDoFHandler
objects.
+ Changed: Many of the functions in DoFTools
+ are now templatized to accept both DoFHandler
+ and hpDoFHandler
objects.
(WB 2003/02/14)
TriaDimensionInfo
and
- DoFDimensionInfo
classes that were used to
+ Changed: The TriaDimensionInfo
and
+ DoFDimensionInfo
classes that were used to
declare typedefs for the iterators have been moved to a namespace
internal (so as to get them out of the class index in the documentation
-- these classes were not meant for use in applications after all), and
- have been renamed to TriaIteratorSelector
- and DoFIteratorSelector
, since that is what
+ have been renamed to TriaIteratorSelector
+ and DoFIteratorSelector
, since that is what
they are.
(WB 2003/02/13)
@@ -135,12 +149,12 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Changed: Due to the demand for different DoFHandler
classes (mainly for the planned
hp-DoFHandler) the DoFHandler has been introduced as a
- template parameter into the DoFAccessor
,
- the DoFObjectAccessor
,
- and the DoFCellAccessor
classes.
- Furthermore the DoFHandler
was
+ template parameter into the DoFAccessor
,
+ the DoFObjectAccessor
,
+ and the DoFCellAccessor
classes.
+ Furthermore the DoFHandler
was
also introduced as template parameter into the
- DoFDimensionInfo
+ DoFDimensionInfo
class. These changes induced several little changes in a couple
of methods to get the code through the compiler. But no
functionality was affected.
@@ -151,14 +165,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FEValues::reinit
function (and likewise in the
- FEFaceValues
and FEFaceValues
and FESubFaceValues
classes) that either take a
- Triangulation::cell_iterator
or a
- DoFHandler::cell_iterator
. That means that
+ Triangulation::cell_iterator
or a
+ DoFHandler::cell_iterator
. That means that
you can compute certain data with only the geometrical information the
former provides, independent of whether degrees of freedom are
associated with this cell or not. However, certain functions of the
- FEValues
class will throw an error if you
+ FEValues
class will throw an error if you
attempt to use them without DoF data being delivered in the
reinitialization call; these functions need to extract values from
finite element fields, and are mostly the
@@ -172,9 +186,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Mapping::transform_real_to_unit_cell
and
- Mapping::transform_unit_to_real_cell
- now only take a Triangulation::cell_iterator
- instead of a DoFHandler::cell_iterator
as
+ Mapping::transform_unit_to_real_cell
+ now only take a Triangulation::cell_iterator
+ instead of a DoFHandler::cell_iterator
as
previously. This is also reasonable, since they only need the geometric
information.
@@ -182,13 +196,13 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FiniteElement::fill_fe_*_values
- now only take a Triangulation::cell_iterator
- instead of a DoFHandler::cell_iterator
as
+ Changed: The FiniteElement::fill_fe_*_values
+ now only take a Triangulation::cell_iterator
+ instead of a DoFHandler::cell_iterator
as
previously. Likewise for FiniteElementBase::compute_2nd
and FESystem::compute_fill
, and the
- Mapping::fill_fe_*_values
functions.
+ Mapping::fill_fe_*_values
functions.
(WB 2003/01/20)
Changes between versions 3.0 and 3.0.1
+
-
-FESystem
) resulted in an
+ (class FESystem
) resulted in an
exception.
(WB 2000/05/10)
FullMatrix::Tmmult
and
- FullMatrix::Tvmult
were broken.
+ Fix: FullMatrix::Tmmult
and
+ FullMatrix::Tvmult
were broken.
(WB 2000/05/08 and 2000/05/26)
DataOut::build_patches
+ DataOut::build_patches
in multithreaded mode fixed.
(Ralf Hartmann, 2000/05/29)
@@ -46,7 +56,7 @@
SparsityPattern::print_gnuplot
+ SparsityPattern::print_gnuplot
wrote rows and columns exchanged. Since most matrices have
symmetric sparsity patterns, this has gone unnoticed by now.
@@ -64,10 +74,4 @@
-Last update $Date$
-
-
-
-
+*/
diff --git a/doc/news/2000/3.0.0-vs-3.1.0.html b/doc/news/3.0.0-vs-3.1.0.h
similarity index 67%
rename from doc/news/2000/3.0.0-vs-3.1.0.html
rename to doc/news/3.0.0-vs-3.1.0.h
index 62dca43124..e745c08eda 100644
--- a/doc/news/2000/3.0.0-vs-3.1.0.html
+++ b/doc/news/3.0.0-vs-3.1.0.h
@@ -1,23 +1,26 @@
-
-
-
-
- Changes between Versions 3.0 and 3.1
-
-This is a quite extensive list of changes made after the release of
-deal.II version 3.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.
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2013, 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+/**
+ * @page changes_between_3_0_0_and_3_1_0 Changes between Version 3.0.0 and 3.1.0
+
+DEAL_2_MAJOR
and
DEAL_2_MINOR
. Their present values
@@ -63,18 +66,18 @@ documentation, etc.
step-9
example program is
now ready, showing several advanced programming techniques in
- deal.II.
+ deal.II.
(WB 2000/07/18)
kdoc2
program to generate the API
documentation. This makes up for much nices documentation and
also works better than the previous kdoc1
.
A copy of kdoc2
is provided within
- the deal.II source tree.
+ the deal.II source tree.
(WB 2000/06/28)
- Changed: License is now deal.II Public
+ Changed: License is now deal.II Public
License, restricting commercial use more explicitely.
(WB/RH/GK)
@@ -165,15 +168,15 @@ documentation, etc.
- Improved: exceptions ExcIO
and ExcIO
and ExcOutOfMemory
are defined globally now.
(GK 2000/12/07)
- Improved: ParameterHandler
now has a
- function log_parameters
which
+ Improved: ParameterHandler
now has a
+ function log_parameters
which
allows output of all parameters to a log file.
(GK 2000/12/07)
@@ -181,26 +184,26 @@ documentation, etc.
New: almost all classes that store data now have a function
- memory_consumption
that returns an
+ memory_consumption
that returns an
estimate of the amount of memory (in bytes) used up by this
class. Supporting functions to compute the size of STL vectors
and other objects can be found the
- MemoryConsumption
namespace.
+ MemoryConsumption
namespace.
(WB 2000/11/27)
- New: Class FunctionDerivative
+ New: Class FunctionDerivative
computes finite difference approximations of a directional
- derivative of a Function
.
+ derivative of a Function
.
(GK 2000/11/13)
- New: The DataOutBase
and
- DataOutBase::Patch
classes have been
+ New: The DataOutBase
and
+ DataOutBase::Patch
classes have been
changed so as to allow output of objects that have an other
dimension than the surrounding space, for example writing faces
instead of cells (this might be useful to write only external
@@ -210,16 +213,16 @@ documentation, etc.
- New: There is a new distance
function
- in the Point
class that calculates the
+ New: There is a new distance
function
+ in the Point
class that calculates the
distance between two points.
(Ralf Hartmann 2000/09/06)
- New:
New: There are now a set of functions
-
New: The classes
-
- New: classes
- New: There is now a function
- Improved:
- Fixed:
- New:
New: There are now functions
-
New: almost all classes that store data now have a function
-
- New:
Fixed: unlike announced in the docs, the
-
- Improved:
Improved: The breakdown criterion of
- New:
- Improved:
New: For recognizing a diverging solver before the maximum
number of steps is reached,
-
Improved: The interface of preconditioner classes has changed.
Preconditioners are now considered linear operators like
- matrices: they have members
New: there is now a function
-
Fix:
-
Fix: the
-
- New: Class
- New:
- New:
- New:
Fix: the
-
- Change: the
Fix: the ``copy-like'' constructor of
-
- New:
- New: there are now functions
- Fix:
Change: the solver classes in LAC lost their first template
argument. Their names are now
-
- New:
- New:
- New:
- New:
- Extend:
New: some arguments of the functions
-
New: almost all classes that store data now have a function
-
- New: The
- New: The
- New: The
- New: The
- Extended: The
- Extended: The
- New: The
- Extended: The
- New: The
- Extended: The
- New: The
Removed: The
-
New: There is now a function
-
Changed: The
-
- New: there is now a class
- New: class
Changed: The functions
-
- New:
- New:
- New: Class
- New: Function
- New: The new function
- New: classes
Fix: slight bug in
-
- New: class
Removed: The obsolete
-
- New:
- Improved:
- Changed:
Changed: enum
-
- New:
Changed: As follows from the existence of this new smoothing,
-
Changed: the
-
New: many functions are now templatized on the data type of the
vector they take or return. They thus now support
-
Changed: The computation of the Jacobian matrices in the
-
- Change:
- Extended:
- New:
- New:
Change: the return value of
-
- New:
- Fix:
- New:
- New:
- New:
- New:
- New:
+This is the list of changes made between the deal.II releases listed above.
+All entries are signed with the names of the author.
+
@@ -27,7 +37,7 @@
class="class">GridOutTimer
now uses the system
- function getrusage (RUSAGE_CHILDREN,
+ New:
::Timer
now uses the system
+ function getrusage (RUSAGE_CHILDREN,
.)
that is need in multithreading. But still the Timer
class does not yet work in
multithreading, as getrusage with flag RUSAGE_CHILDREN gives always
@@ -230,7 +233,7 @@ documentation, etc.
outer_product
that for the outer
+ outer_product
that for the outer
product of tensors.
(WB 2000/07/23)
@@ -238,11 +241,11 @@ documentation, etc.
Patterns::Integer
- and Patterns::Double
now allow that
+ Patterns::Integer
+ and Patterns::Double
now allow that
a range may be specified in which the parameter shall
be. Furthermore, instead of a class,
- Patterns
is now a namespace, so it
+ Patterns
is now a namespace, so it
can be reopened in case you want to write another pattern class
and want to put it into the same namespace.
@@ -250,7 +253,7 @@ documentation, etc.
QMilne
and QMilne
and QWeddle
for closed Newton-Cotes-formulæ of
orders 7 and 9, respectively.
@@ -258,7 +261,7 @@ documentation, etc.
invert
+ New: There is now a function
invert
(Tensor<2,dim>)
that returns the inverse of a tensor of
rank 2.
@@ -272,7 +275,7 @@ documentation, etc.
Subscriptor
prints the
+ Improved: Subscriptor
prints the
real class name if a subscribed object is deleted.
(GK 2000/04/12)
@@ -286,7 +289,7 @@ documentation, etc.
-SparseILU
had two bugs which
+ Fixed: SparseILU
had two bugs which
are now fixed.
(Oliver Rheinbach, 2001/02/02)
@@ -300,7 +303,7 @@ documentation, etc.
BlockDiagonalMatrix
is a
+ New: BlockDiagonalMatrix
is a
template that generates a matrix with multiple copies of the
same block on the diagonal.
@@ -311,7 +314,7 @@ documentation, etc.
Improved: Krylov-space solvers do not use the function residual
anymore. This allows easier implementation of new matrix
- classes. SolverGMRES
now also counts
+ classes. SolverGMRES
now also counts
the first iteration step. Finally, all solvers inherit a Subscriptor
.
@@ -320,8 +323,8 @@ documentation, etc.
SparsityPattern::symmetrize
and
- SparseMatrix::symmetrize
that
+ SparsityPattern::symmetrize
and
+ SparseMatrix::symmetrize
that
generate a symmetric matrix from a non-symmetric one.
(WB 2000/12/02)
@@ -329,7 +332,7 @@ documentation, etc.
memory_consumption
that returns an
+ memory_consumption
that returns an
estimate of the amount of memory (in bytes) used up by this
class.
@@ -337,7 +340,7 @@ documentation, etc.
+ New:
SparseMatrix
returns the number of entries that are actually nonzero.
@@ -346,7 +349,7 @@ documentation, etc.
FullMatrix::norm2
function did not
+ FullMatrix::norm2
function did not
return the Frobenius norm of a matrix, but its square. This is
fixed now.
@@ -354,7 +357,7 @@ documentation, etc.
PreconditionBlockSOR
PreconditionBlockSOR
::Tvmult(...)
is implemented.
(GK 2000/07/07)
@@ -363,22 +366,22 @@ documentation, etc.
SolverBicgstab
can be changed by the use
- of SolverBicgstab::AdditionalData
.
+ of SolverBicgstab::AdditionalData
.
(GK 2000/07/07)
SolverRichardson
has a
- transposed solver Tsolve(...)
. It
- uses the functions Tvmult(...)
of
+ New: SolverRichardson
has a
+ transposed solver Tsolve(...)
. It
+ uses the functions Tvmult(...)
of
the provided matrix and preconditioner.
(GK 2000/07/07)
FullMatrix
FullMatrix
::invert(...)
now inverts matrices of all
sizes. If there is no hardcoded inversion, gauss_jordan()
is used implicitly.
@@ -389,14 +392,14 @@ documentation, etc.
SolverControl
returns
- failure
also if the residual
+ SolverControl
returns
+ failure
also if the residual
increases over the start residual by a specific factor. This
- factor is given to the SolverControl
- object by the set_failure_criterion
+ factor is given to the SolverControl
+ object by the set_failure_criterion
function. After calling the latter function, checking of this
additional failure criterion may again be disabled by calling
- clear_failure_criterion
.
+ clear_failure_criterion
.
(Ralf Hartmann 2000/06/26)
vmult
- and Tvmult
instead of the old vmult
+ and Tvmult
instead of the old operator()
. This will allow the
implementation of further non-symmetric solvers.
@@ -414,13 +417,13 @@ documentation, etc.
SparseMatrix::el
that does mostly
- the same as SparseMatrix::operator()
,
+ SparseMatrix::el
that does mostly
+ the same as SparseMatrix::operator()
,
but returns a zero if elements of the matrix are accessed that
are not in the sparsity pattern. Thus, the new function allows
to actually traverse rows or columns of the matrix without
taking care of the sparsity pattern, while
- SparseMatrix::operator()
should be
+ SparseMatrix::operator()
should be
used to write algorithms more efficiently.
(WB 2000/06/02)
@@ -428,7 +431,7 @@ documentation, etc.
SparsityPattern::print_gnuplot
+ SparsityPattern::print_gnuplot
wrote rows and columns exchanged. Since most matrices have
symmetric sparsity patterns, this has gone unnoticed by now.
@@ -437,30 +440,30 @@ documentation, etc.
FullMatrix::Tvmult
function
+ FullMatrix::Tvmult
function
suffered from the same problems as the
- FullMatrix::Tmmult
function. This
+ FullMatrix::Tmmult
function. This
is now fixed as well.
(WB 2000/05/26)
PreconditionBlockJacobi
.
+ New: Class PreconditionBlockJacobi
.
(GK 2000/05/24)
SolverControl
has an interface
- to ParameterHandler
, defining and
+ New: SolverControl
has an interface
+ to ParameterHandler
, defining and
reading parameters from a file automatically.
(GK 2000/05/24)
BlockIndices
: Class that
+ New: BlockIndices
: Class that
manages the conversion of global indices into a block
vector/matrix/... to the indices local to each of the blocks.
@@ -468,8 +471,8 @@ documentation, etc.
BlockSparsityPattern
and
- BlockSparseMatrix
: Classes that
+ New: BlockSparsityPattern
and
+ BlockSparseMatrix
: Classes that
represent matrices that are composed of sparse matrices.
(WB 2000/05/08)
@@ -477,20 +480,20 @@ documentation, etc.
FullMatrix::mmult
and
- FullMatrix::Tmmult
code don't
+ FullMatrix::mmult
and
+ FullMatrix::Tmmult
code don't
resize their output argument any more, as this is not common
style in the library. Furthermore,
- FullMatrix::Tmmult
was utterly
+ FullMatrix::Tmmult
was utterly
broken.
(WB 2000/05/08)
matrix_norm
functions
+ Change: the matrix_norm
functions
of sparse and full matrices are renamed to
- matrix_norm_square
, since they in
+ matrix_norm_square
, since they in
fact return the square of the norm. This should avoid confusion
in some cases.
@@ -499,7 +502,7 @@ documentation, etc.
SparsityPattern
that copies another
+ SparsityPattern
that copies another
object and adds some off-diagonals had a bug that caused an
exception in some cases. This is now fixed.
@@ -507,7 +510,7 @@ documentation, etc.
SwappableVector
: Class that
+ New: SwappableVector
: Class that
allows to swap out the data of a vector to disk and reload it
later on. It also has a function to preload the data before its
use in a separate thread if the library is configured for
@@ -517,9 +520,9 @@ documentation, etc.
Vector::swap
- and BlockVector::swap
, as well as
- global functions swap(u,v)
that
+ New: there are now functions Vector::swap
+ and BlockVector::swap
, as well as
+ global functions swap(u,v)
that
exchange the data of two vectors without needing a temporary
vector and without copying around data. Their run-time is
therefore independent of the length of the vectors.
@@ -528,7 +531,7 @@ documentation, etc.
SolverCG
counts steps properly.
+ Fix: SolverCG
counts steps properly.
(GK 2000/04/25)
SolverXX<VECTOR>
, where
- XX
denotes the name of the solver
+ SolverXX<VECTOR>
, where
+ XX
denotes the name of the solver
(e.g. CG, GMRES, etc). Furthermore, the
- inheritance from Solver
was made private
+ inheritance from Solver
was made private
to reflect the logical structure.
(GK 2000/04/25)
EigenInverse
implements inverse
+ New: EigenInverse
implements inverse
iteration by Wieland.
(GK 2000/04/20)
EigenPower
implements power
+ New: EigenPower
implements power
method by von Mises
(GK 2000/04/19)
PreconditionBlockSOR::set_omega
+ New: PreconditionBlockSOR::set_omega
allows to change the relaxation parameter.
(GK 2000/04/12)
SolverXX
: There is a virtual function
+ New: SolverXX
: There is a virtual function
print_vectors
called in every step. It is void in the
solver itself but can be used to print intermediate iteration
vectors.
@@ -583,7 +586,7 @@ documentation, etc.
DoFTools::extract_boundary_dofs
+ Extend: DoFTools::extract_boundary_dofs
now allows to also specify which boundary conditions shall be
considered.
@@ -592,12 +595,12 @@ documentation, etc.
DoFHandler::n_boundary_dofs
,
- DoFTools::extract_boundary_dofs
,
+ DoFHandler::n_boundary_dofs
,
+ DoFTools::extract_boundary_dofs
,
and
- DoFTools::map_dof_to_boundary_indices
- are changed from list
to
- set
, since that resembles more
+ DoFTools::map_dof_to_boundary_indices
+ are changed from list
to
+ set
, since that resembles more
closely the purpose of the parameter, and makes computations
slightly faster.
@@ -606,7 +609,7 @@ documentation, etc.
memory_consumption
that returns an
+ memory_consumption
that returns an
estimate of the amount of memory (in bytes) used up by this
class.
@@ -614,31 +617,31 @@ documentation, etc.
ConstraintMatrix::add_entries
+ New: The ConstraintMatrix::add_entries
function add several constraints at once.
(WB 2000/10/26)
DoFRenumbering::random
+ New: The DoFRenumbering::random
function renumbers degrees of freedom in a random way.
(WB 2000/10/22)
TriaAccessor
now has a
- function point_inside
that checks
+ New: The TriaAccessor
now has a
+ function point_inside
that checks
whether a certain point is inside a given cell.
(Thomas Richter 2000/10/12)
FiniteElement
has got two
- new functions transform_unit_to_real_cell
-
and transform_real_to_unit_cell
+ New: The
FiniteElement
has got two
+ new functions transform_unit_to_real_cell
+
and transform_real_to_unit_cell
. They allow to transform points from reference (unit)
cell to real cell and visa versa. transform_real_to_unit_cell
involves a
@@ -649,7 +652,7 @@ documentation, etc.
Triangulation
+ Extended: The Triangulation
class can handle boundary information in 3d as well
(i.e. lines and quads in 3d with special material IDs).
@@ -658,7 +661,7 @@ documentation, etc.
GridIn
+ Extended: The GridIn
class can now read 3D UCD data, including boundary information
(i.e. lines and quads in 3d with special material IDs).
@@ -667,7 +670,7 @@ documentation, etc.
GridRefinement::refine_and_coarsen_optimize
+ New: The GridRefinement::refine_and_coarsen_optimize
function implements an alternative way to flag cells for
refinement and coarsening.
@@ -675,13 +678,13 @@ documentation, etc.
GridIn::delete_unused_vertices
+ Extended: The GridIn::delete_unused_vertices
function now eliminates vertices from the input that are not
referenced by any of the cells in the input file. This makes is
simpler to delete some cells from the input file by hand,
without the need to update the vertex lists, which can be
tiring as several cells usually use each vertex. All functions
- in the GridIn
reading grids in
+ in the GridIn
reading grids in
several input files call this function before passing the data
to the triangulation object.
@@ -689,23 +692,23 @@ documentation, etc.
GridIn
+ New: The GridIn
class can now read the basics of grids in DB Mesh format.
(WB 2000/09/26)
KellyErrorEstimator
+ Extended: The KellyErrorEstimator
class is now able to estimate errors for several solution
vectors at the same time, provided they live on the same
- DoFHandler
object.
+ DoFHandler
object.
(WB 2000/09/11)
DataOut_Faces
class allows to
+ New: The DataOut_Faces
class allows to
output faces instead of cells. This might be handy for 3d
computations if one is only interested in surface plots, or
cuts through the domain.
@@ -715,21 +718,21 @@ documentation, etc.
DataOut_Old
class has finally gone for
+ DataOut_Old
class has finally gone for
good. It was already deprecated in version 3.0, and has been
superceded for a long time by the framwork of classes around
- DataOutBase
and
- DataOut
.
+ DataOutBase
and
+ DataOut
.
(WB 2000/09/07)
DoFHandler::n_boundary_dofs
+ DoFHandler::n_boundary_dofs
that takes the list of selected boundary indicators as a
- list
of values, rather than the
- usual map
of pairs of boundary
+ list
of values, rather than the
+ usual map
of pairs of boundary
indicators and function object pointers.
(WB 2000/08/25)
@@ -737,9 +740,9 @@ documentation, etc.
map_dof_to_boundary_index
- functions have been moved from the DoFHandler
- to the DoFTools
class, in order to
+ map_dof_to_boundary_index
+ functions have been moved from the DoFHandler
+ to the DoFTools
class, in order to
further remove code from the big classes which is necessarily
needed there.
@@ -747,7 +750,7 @@ documentation, etc.
DataOutRotation
+ New: there is now a class DataOutRotation
that can be used to output data which has been computed
exploiting rotational symmetry, on the original domain. Thus,
the output is of one dimension higher than the computation was,
@@ -758,8 +761,8 @@ documentation, etc.
HalfHyperShellBoundary
- and GridGenerator::half_hyper_shell
+ New: class HalfHyperShellBoundary
+ and GridGenerator::half_hyper_shell
generate a half shell, useful for computations with a shell
domain and rotational symmetry.
@@ -768,15 +771,15 @@ documentation, etc.
Triangulation::refine
,
- Triangulation::coarsen
,
+ Triangulation::refine
,
+ Triangulation::coarsen
,
Triangulation::refine_and_coarsen_fixed_fraction
,
and
Triangulation::refine_and_coarsen_fixed_number
have been moved from the triangulation class to a separate
- class GridRefinement
as they are not
+ class GridRefinement
as they are not
intricately bound to the triangulation but rather form a
distinct class of functions that flag cells for refinement or
coarsening based on error indicators.
@@ -785,7 +788,7 @@ documentation, etc.
DataOut::clear_input_data_references
+ New: DataOut::clear_input_data_references
clears all reference to input data vectors and to the DoFHandler
. This function may be useful
after the patches have been built, to release memory as early
@@ -795,7 +798,7 @@ documentation, etc.
class DerivativeApproximation
+ New: class DerivativeApproximation
approximates the norm of the gradient or second derivative of a
finite element field on each cell from finite difference
approximations.
@@ -807,9 +810,9 @@ documentation, etc.
Fix: Add a missing assertions in FEValuesBase::get_function_*
. If an ExcAccessToUninitializedField
is now thrown
- then probably an update_values
or
- update_gradients
is missing in the
- UpdateFlags
of a used update_values
or
+ update_gradients
is missing in the
+ UpdateFlags
of a used FEValues
. Adding this assertion uncovered
several other errors which are now also fixed; these errors
were dormant, since the values of finite elements are always
@@ -821,7 +824,7 @@ documentation, etc.
DoFRenumbering
now has
+ New: Class DoFRenumbering
now has
functions for cell-wise downstream renumbering for
discontinuous elements. The parameters of the function sort_selected_dofs_back
have been
@@ -832,7 +835,7 @@ documentation, etc.
VectorTools
VectorTools
::compute_mean_value
integrates the mean
value of one component of a finite element function.
@@ -840,8 +843,8 @@ documentation, etc.
get_face
- of FEFaceValues
and get_face
+ of FEFaceValues
and FESubfaceValues
returns an iterator of the
present face. This is the face, for that the FE(Sub)FaceValues
object was reinited
@@ -851,10 +854,10 @@ documentation, etc.
FEDG_Px
implement
+ New: classes FEDG_Px
implement
complete polynomial spaces of degree x on
quadrilaterals. Since they have less degrees of freedom than
- FEDG_Qx
, there is no continuous
+ FEDG_Qx
, there is no continuous
version for these elements. Implementation for P4 and 3D is
still incomplete.
@@ -863,16 +866,16 @@ documentation, etc.
DataOut::build_patches
+ DataOut::build_patches
in multithreaded mode fixed.
(Ralf Hartmann, 2000/05/29)
FETools
performs
+ New: class FETools
performs
interpolations and extrapolations of discrete functions from one
- FiniteElement
to another FiniteElement
to another FiniteElement
. It also provides the local
interpolation matrices that interpolate on each
cell. Furthermore it provides the interpolation difference
@@ -882,7 +885,7 @@ documentation, etc.
MatrixCreator::create_interpolation_matrix
+ MatrixCreator::create_interpolation_matrix
function is now removed.
DoFTools::make_flux_sparsity_pattern
+ New: DoFTools::make_flux_sparsity_pattern
can be optimized by providing two coefficient matrices.
(GK 2000/05/25)
VectorTools::integrate_difference
+ Improved: VectorTools::integrate_difference
allows for vector-valued weight functions. L1 and
Linfinity norms are calculated correctly.
@@ -906,7 +909,7 @@ documentation, etc.
FE_DGx::restriction
is
+ Changed: FE_DGx::restriction
is
not an interpolation any more but a local projection which is
more reasonable for DG elements.
@@ -915,14 +918,14 @@ documentation, etc.
MeshSmoothing
is moved into the
- Triangulation
class.
+ MeshSmoothing
is moved into the
+ Triangulation
class.
(Ralf Hartmann 2000/05/18)
Triangulation
+ New: Triangulation
is a new mesh smoothing. A mesh of patch level 1 consists of
patches, i.e. they consists of cells that are all refined at
least once.
@@ -930,7 +933,7 @@ documentation, etc.
maximum_smoothing
will include this
+ maximum_smoothing
will include this
smoothing.
MatrixTools::apply_boundary_values
+ MatrixTools::apply_boundary_values
now uses a much faster algorithm when working on matrices with
symmetric sparsity patterns. On the other hand, it does no more
eliminate whole rows when a matrix has a non-symmetric sparsity
@@ -966,29 +969,29 @@ documentation, etc.
Vector<float>
, but also
- BlockVector<...>
. An
+ Vector<float>
, but also
+ BlockVector<...>
. An
incomplete and growing list of functions that were treated in
this way is:
DoFAccessor::get_dof_values
,
+ DoFAccessor::get_dof_values
,
DoFAccessor::set_dof_values
,
+ DoFAccessor::set_dof_values
,
DoFAccessor::get_interpolated_dof_values
,
+ DoFAccessor::get_interpolated_dof_values
,
DoFAccessor::set_dof_values_by_interpolation
,
+ DoFAccessor::set_dof_values_by_interpolation
,
FEValues::get_function_values
,
+ FEValues::get_function_values
,
FEValues::get_function_grads
,
+ FEValues::get_function_grads
,
FEValues::get_function_2nd_derivatives
,
+ FEValues::get_function_2nd_derivatives
,
MatrixTools::apply_boundary_values
,
+ MatrixTools::apply_boundary_values
,
ConstraintMatrix
.
+ Several functions in ConstraintMatrix
.
(WB 2000/05/16 and later)
@@ -996,7 +999,7 @@ documentation, etc.
FEValues
class is now done more
+ FEValues
class is now done more
efficiently. The speedup is in the range of a factor of 40 for
3D.
@@ -1004,7 +1007,7 @@ documentation, etc.
DoFTools::make_hanging_node_constraints ()
+ Change: DoFTools::make_hanging_node_constraints ()
does not use the user flags any more, and can thus run in
parallel more than once.
@@ -1012,24 +1015,24 @@ documentation, etc.
DoFTools::make_sparsity_pattern ()
+ Extended: DoFTools::make_sparsity_pattern ()
now accepts a template parameter as sparsity pattern. This
allows to use this function for the usual
- SparsityPattern
, or for
- BlockSparsityPattern
arguments.
+ SparsityPattern
, or for
+ BlockSparsityPattern
arguments.
(WB 2000/05/15)
DoFTools::extract_hanging_node_dofs ()
+ New: DoFTools::extract_hanging_node_dofs ()
identifies nodes that will be constrained by hanging node constraints.
(WB 2000/05/12)
DoFRenumbering::sort_selected_dofs_back ()
+ New: DoFRenumbering::sort_selected_dofs_back ()
sorts selected degrees of freedom to the end of the index
range.
@@ -1038,29 +1041,29 @@ documentation, etc.
DoFHandler::max_couplings_between_dofs ()
- is bounded by DoFHandler::n_dofs()
.
+ DoFHandler::max_couplings_between_dofs ()
+ is bounded by DoFHandler::n_dofs()
.
(Ralf Hartmann 2000/05/11)
FEValuesBase::get_cell ()
+ New: FEValuesBase::get_cell ()
returns present cell.
(Ralf Hartmann 2000/05/11)
FESystem::reinit()
generated
- an exception if update_support_points
+ Fix: FESystem::reinit()
generated
+ an exception if update_support_points
was set.
(WB 2000/05/10)
IntergridMap::get_{source,destination}_grid
+ New: IntergridMap::get_{source,destination}_grid
functions return the grids for which the map was created.
(WB 2000/04/19)
@@ -1075,7 +1078,7 @@ documentation, etc.
DoFTools::extract_boundary_dofs
+ New: DoFTools::extract_boundary_dofs
finds all degrees of freedom which are at the boundary and belong to
specified components.
@@ -1083,7 +1086,7 @@ documentation, etc.
DoFTools::compute_intergrid_constraints
+ New: DoFTools::compute_intergrid_constraints
allows to use different discretization grids for different
variables.
@@ -1091,7 +1094,7 @@ documentation, etc.
DataOut::clear_data_vectors
+ New: DataOut::clear_data_vectors
allows to re-use an object without deleting the DoFHandler
.
@@ -1099,17 +1102,13 @@ documentation, etc.
class DoFPrintSolverStep
prints
+ New: class DoFPrintSolverStep
prints
intermediate vectors of a solver as finite element functions using
- DataOut
.
+ DataOut
.
(GK 2000/04/05)
-Last update $Date$
-
-
-
+*/
diff --git a/doc/news/2001/3.1.0-vs-3.1.1.html b/doc/news/3.1.0-vs-3.1.1.h
similarity index 81%
rename from doc/news/2001/3.1.0-vs-3.1.1.html
rename to doc/news/3.1.0-vs-3.1.1.h
index a8d3d56845..eb2e84fe42 100644
--- a/doc/news/2001/3.1.0-vs-3.1.1.html
+++ b/doc/news/3.1.0-vs-3.1.1.h
@@ -1,16 +1,26 @@
-
-
-
-
- Changes between versions 3.1 and 3.1.1
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2013, 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+/**
+ * @page changes_between_3_1_0_and_3_1_1 Changes between Version 3.1.0 and 3.1.1
+
+
write_ucd_faces
function are now also
1-based. This, to be consistent with the vertex numbers given
- by the GridOut
::GridOut
::write_ucd
function.
(RH 2001/04/20)
@@ -45,7 +55,7 @@
Fixed: When using Neuman boundary functions in the
- KellyErrorEstimator
class, it was
+ KellyErrorEstimator
class, it was
assumed that the function object had Function::vector_value
overloaded, even
in the scalar case. We now use Triangulation
::ExcMultiplySetLineInfoOfLine
exception,
- that is thrown if the SubCellData
+ that is thrown if the SubCellData
that is given to Triangulation
::create_triangulation
, multiply includes
the line info of a specific line. Before the fix the wrong
- ExcInteriorLineCantBeBoundary
+ ExcInteriorLineCantBeBoundary
exception was thrown.
(RH 2001/04/03)
@@ -121,7 +131,7 @@
- New: The class GridReordering::Cell
has
+ New: The class GridReordering::Cell
has
now a copy constructor to work around a bug in a gcc3.0
snapshot.
@@ -169,9 +179,4 @@
+This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author. +
@@ -81,7 +82,7 @@ documentation, etc.
Improved: libraries are now all in a subdirectory lib in the
- deal.II home directory. It is now easy to
+ deal.II home directory. It is now easy to
make this directory a link to put the libraries on a faster
disk.
@@ -89,8 +90,8 @@ documentation, etc.
FiniteElements
- and Mappings
+ New Design of FiniteElements
+ and Mappings
New: The finite element @@ -118,23 +119,23 @@ documentation, etc.
The new implementation uses a totally new structure of
- communication between FEValues
, the
- FiniteElements
and the FEValues
, the
+ FiniteElements
and the Mappings
. Despite of this, the new
structure will almost not be 'visible' to the user of
- deal.II as we tried to retain the interface
+ deal.II as we tried to retain the interface
to the user (mainly that of FEValues
) as far as possible.
Together with this new design comes a reduction of 25000(!)
- lines of deal.II code. This elimination
+ lines of deal.II code. This elimination
mainly affected code that previously was machine generated
(e.g. by maple). In view of almost unchanged execution times of
applications, the faster compilation and additional
functionality constitutes a significant improvement of
- deal.II. Results produced by the new code
+ deal.II. Results produced by the new code
match those of the old design up to machine precision.
(RH & GK 2001/03/13)
@@ -173,7 +174,7 @@ documentation, etc.
- New: Function QProjector::project_to_child
+ New: Function QProjector::project_to_child
generates quadrature formulae which act on the area which a
child would occupy.
@@ -182,7 +183,7 @@ documentation, etc.
Changed: The examples classes in the base directory are now
- moved into a namespace Functions
of
+ moved into a namespace Functions
of
their own. This improves encapsulation, but also keeps the
documentation of these functions together, as they were
previously scrambled all over the screen in the documentation
@@ -192,8 +193,8 @@ documentation, etc.
- New: classes FourierSineFunction
- and FourierCosineFunction
,
+ New: classes FourierSineFunction
+ and FourierCosineFunction
,
resembling one mode of a Fourier decomposition. Classes FourierSineSum
and FourierCosineSum
, resembling sums of such
@@ -203,16 +204,16 @@ documentation, etc.
- New: class vector2d
was introduced
- in analogy to STL class vector
. The
+ New: class vector2d
was introduced
+ in analogy to STL class vector
. The
bew class provides a two-dimensional array and replaces the use
- of FullMatrix
in the base library.
+ of FullMatrix
in the base library.
(GK 2001/05/21)
- Improved: JobIdentifier
::JobIdentifier
::operator()
includes host name if
supported by the operating system
@@ -225,19 +226,19 @@ documentation, etc.
automatically computes the gradient of a function by employing
numerical difference quotients. This only, if the user function
does not provide the gradient function himself. This class can
- replace the Function
class as base
- class for user defined Function
+ replace the Function
class as base
+ class for user defined Function
classes.
This new class can be used if the user only implements the
- value
function but wants to call
- also the gradient
functions.
+ value
function but wants to call
+ also the gradient
functions.
(RH 2001/05/15)
- New: The Quadrature
class now has a
+ New: The Quadrature
class now has a
constructor that only accepts quadrature points and sets the
weights to invalid values.
@@ -245,7 +246,7 @@ documentation, etc.
- New: The function Logstream
::Logstream
::get_prefix
allows access to the prefix
string used for log-files.
@@ -261,7 +262,7 @@ documentation, etc.
- New: The Threads
now has a barrier
+ New: The Threads
now has a barrier
class in order to synchronise multiple threads. In
multithreaded mode, this is an alias to the ACE_Barrier
class of the ACE library, if
@@ -293,8 +294,8 @@ documentation, etc.
- New: LagrangeEquidistant
is a new
- class derived from Polynomial
+ New: LagrangeEquidistant
is a new
+ class derived from Polynomial
providing the 1d Lagrange interpolation of degree
n
of n+1
equidistant support points
in [0,1]
. It is implemented up to degree 10.
@@ -305,7 +306,7 @@ documentation, etc.
- New: The new Polynomial
class can
+ New: The new Polynomial
class can
be used as base class for all 1d polynomials. It stores the
coefficients of the polynomial and uses the Horner scheme to
evaluate values and all derivates.
@@ -315,12 +316,12 @@ documentation, etc.
New: function contract
for two arguments of
- Tensor<1,dim>
+ Tensor<1,dim>
(GK 2001/03/05)
New: New: Fix: Fix:
New: function
- New: Function
- New: The
- New: Function
- New: There is now a class
- Changed: Base class
- New: Classes
New: There is now a function
-
- New: The
- Changed: The
- New:
- New: Class
- New: Class
New: There are now functions
-
- New:
- New: The Changed: Solver functions Changed: Solver functions
- New: The functions
- New: class
- New: Class
- New:
- New:
- New:
New: Member function
-
Fixed: in a rather rare case, some work was done twice in the
-
- New: There is now a class
- Changed: The
- Extended:
New: Implement
-
- New:
- Changed: the
Fixed: due to a bug in gcc, the compiler did not check that we
did not use the set of given boundary indicators to the
- Logstream
::
class to modify the appearance of
the output have been moved from local classes of the Logstream
::log_time_differences (bool)
makes Logstream
print the time since the last
log line instead of accumulated time since program start.
@@ -328,7 +329,7 @@ documentation, etc.
(GK 2001/03/05)
Logstream
::
Logstream
::pop()
does not perform anything on empty
stacks.
@@ -347,7 +348,7 @@ documentation, etc.
contract
for two arguments of
- Tensor<1,dim>
+ Tensor<1,dim>
(GK 2001/01/15)
FullMatrix::symmetrize()
.
+ New: Function FullMatrix::symmetrize()
.
(WB 2001/09/20)
FullMatrix
class now has a
- function operator*=
, which simply
+ New: The FullMatrix
class now has a
+ function operator*=
, which simply
scales the matrix.
(WB 2001/09/02)
BlockSparseMatrix::el()
,
- just like SparseMatrix::el()
.
+ New: Function BlockSparseMatrix::el()
,
+ just like SparseMatrix::el()
.
(WB 2001/08/21)
MatrixOut
+ New: There is now a class MatrixOut
which can be used to convert a matrix into a graphical output,
for example in order to see visually that a matrix is
diagonally dominant or not.
@@ -398,25 +399,25 @@ documentation, etc.
Solver
and all
- Preconditioner
classes are now
- derived from Subscriptor
.
- Class PreconditionLACSolver
now uses
+ Changed: Base class Solver
and all
+ Preconditioner
classes are now
+ derived from Subscriptor
.
+ Class PreconditionLACSolver
now uses
smartpointers to the given solver and preconditioner
objects. You will, therefore, have to derive your own
preconditioners and solvers from Subscriptor
if you want to use it with
- PreconditionLACSolver
.
+ PreconditionLACSolver
.
(WB 2001/08/16)
Vector
and
- BlockVector
now have member functions
- operator*=
which scale the vectors
+ New: Classes Vector
and
+ BlockVector
now have member functions
+ operator*=
which scale the vectors
by a constant factor. These functions are aliases for the
- scale
member functions except that
+ scale
member functions except that
they return a reference to themselves.
(WB 2001/08/14)
@@ -424,16 +425,16 @@ documentation, etc.
FullMatrix::precondition_Jacobi
. The
- PreconditionJacobi
class is
+ FullMatrix::precondition_Jacobi
. The
+ PreconditionJacobi
class is
therefore now also applicable with the full matrix class.
(WB 2001/08/11)
Vector
and
- BlockVector
classes can now be
+ New: The Vector
and
+ BlockVector
classes can now be
initialized using a new constructor that takes two iterators
that denote a range of elements which are to be copied.
@@ -441,7 +442,7 @@ documentation, etc.
SolverCG
class now
+ Changed: The SolverCG
class now
saves the initial matrix vector product if the initial value of
the solution is vector is zero, as it is common practice to use
this is starting vector.
@@ -450,7 +451,7 @@ documentation, etc.
SparsityPattern::reinit
no
+ New: SparsityPattern::reinit
no
more throws an error if the given maximal row lengths are all
zero.
@@ -458,7 +459,7 @@ documentation, etc.
CompressedBlockSparsityPattern
+ New: Class CompressedBlockSparsityPattern
may be used as an intermediate form of the BlockSparsityPattern
.
@@ -466,7 +467,7 @@ documentation, etc.
CompressedSparsityPattern
+ New: Class CompressedSparsityPattern
may be used as an intermediate form of the SparsityPattern
class if memory
requirements are tight during construction of the sparsity
@@ -477,19 +478,19 @@ documentation, etc.
SparsityPattern::copy_from
and
- SparseMatrix::copy_from
+ SparsityPattern::copy_from
and
+ SparseMatrix::copy_from
that can be used to construct sparsity patterns and matrix at
once, i.e. without setting up a sparsity pattern element by
element, possibly after using a way too large value for the
maximal row length, then calling
- SparsityPattern::compress
etc.
+ SparsityPattern::compress
etc.
(WB 2001/05/07)
BlockIndices::block_size
+ New: BlockIndices::block_size
returns the size of a specified block.
(WB 2001/05/07)
@@ -511,7 +512,7 @@ documentation, etc.
FilteredMatrix
class is a
+ New: The FilteredMatrix
class is a
replacement for the MatrixTools::apply_boundary_values
function for cases where you would like to solve several times
@@ -531,7 +532,7 @@ documentation, etc.
(WB 2001/04/23)
solve
+ solve
return void now. If the solver has not converged within the
maximum number of iterations or encounters a breakdown, it
throws an exception of type .
FullMatrix
::FullMatrix
::mmult
and Tmmult
now have an additional
adding
argument. If this flag is
@@ -558,7 +559,7 @@ documentation, etc.
SchurMatrix
implements
+ New: class SchurMatrix
implements
a Schur complement for block matrices. It provides matrix-vector
multiplication suitable for iterative methods as well as pre- and
post-processing of right hand side and slution, respectively.
@@ -570,7 +571,7 @@ documentation, etc.
Removed: The explicite instantiations of SparseMatrix<long double>
are
removed as a prerelease of gcc3.0 fails to compile it. A user
- of SparseMatrix<long double>
+ of SparseMatrix<long double>
needs now to include
lac/include/lac/sparse_matrix.templates.h
into his
source file and to use an appropriate compiler, e.g. gcc2.95.2 or
@@ -594,8 +595,8 @@ documentation, etc.
Harwell Subroutine Library, and support
classes
- SparseDirectMA27
and
- SparseDirectMA47
+ SparseDirectMA27
and
+ SparseDirectMA47
for the sparse direct solvers MA27 and MA47.
(WB 2001/01/30)
@@ -609,21 +610,21 @@ documentation, etc.
MappingQ1Eulerian
+ New: Class MappingQ1Eulerian
implementing an Eulerian mapping.
(Michael Stadler 2001/09/24)
VectorTools::create_boundary_right_hand_side
+ New: VectorTools::create_boundary_right_hand_side
integrates boundary forces for inhomogeneous Neumann boundary values.
(WB 2001/09/13)
DoFTools::make_flux_sparsity_pattern
+ New: DoFTools::make_flux_sparsity_pattern
now exists also for 1d.
(WB 2001/09/03)
@@ -642,7 +643,7 @@ documentation, etc.
ConstraintMatrix::close
+ New: ConstraintMatrix::close
now simply returns instead of throwing an exception, if the
matrix was already closed.
@@ -651,21 +652,21 @@ documentation, etc.
ConstraintMatrix::is_identity_constrained
.
+ ConstraintMatrix::is_identity_constrained
.
(WB 2001/08/29)
KellyErrorEstimator
class when in
+ KellyErrorEstimator
class when in
multithread mode. This is now fixed.
(WB 2001/08/24)
GridTools
+ New: There is now a class GridTools
which provides algorithms working on triangulations. At
present, it offers a function computing the diameter of a
triangulation.
@@ -674,7 +675,7 @@ documentation, etc.
MatrixCreator
and MatrixCreator
and MatrixTools
class have lost their template
arguments. Rather, the individual functions now are templated
on their own, so the compiler can pick out the correct space
@@ -684,7 +685,7 @@ documentation, etc.
ConstraintMatrix::merge
+ Extended: ConstraintMatrix::merge
can now handle arguments which further constrain the present object.
(WB 2001/07/30)
@@ -692,19 +693,19 @@ documentation, etc.
DoFTools::make_sparsity_pattern
,
- DoFTools::make_boundary_sparsity_pattern
,
+ DoFTools::make_sparsity_pattern
,
+ DoFTools::make_boundary_sparsity_pattern
,
and
- ConstraintMatrix::condense
to work on
- the CompressedSparsityPattern
and
- CompressedBlockSparsityPattern
and
+ ConstraintMatrix::condense
to work on
+ the CompressedSparsityPattern
and
+ CompressedBlockSparsityPattern
and
classes.
(WB 2001/06/22)
FE*Values::get_quadrature
+ New: FE*Values::get_quadrature
returns a reference to the quadrature formula used by a
FEValues object.
@@ -722,7 +723,7 @@ documentation, etc.
GeometryInfo
class
+ Changed: the GeometryInfo
class
has been reverted from a general template that calculates the
values of its member variables by recursion/induction to a set
of explicitely specialized classes. This seemed necessary since
@@ -742,7 +743,7 @@ documentation, etc.
Changed: the classes that denote flags to the TimeStepBase_Tria
class have been move
from local classes to a namespace of their own, names
- TimeStepBase_Tria_Flags
.
+ TimeStepBase_Tria_Flags
.
(WB 2001/05/23)
DoFTools::extract_boundary_dofs
+ DoFTools::extract_boundary_dofs
function in 1d. That set was therefore ignored. This is now
fixed.
@@ -762,8 +763,8 @@ documentation, etc.
class="class">GridOutGridOut
class to a namespace names
- GridOutFlags
and have lost the
- trailing Flags
part in their name.
+ GridOutFlags
and have lost the
+ trailing Flags
part in their name.
This change was necessary as C++ does not allow explicit
specialization of member classes; the previous use in the
library was only accepted by GCC as an extension.
@@ -774,11 +775,11 @@ documentation, etc.
New: The functions DoFTools::map_dof_to_boundary_indices
,
- DoFTools::make_boundary_sparsity_pattern
,
- DoFHandler::n_boundary_dofs
,
+ DoFTools::make_boundary_sparsity_pattern
,
+ DoFHandler::n_boundary_dofs
,
DoFHandler::max_couplings_between_boundary_dofs
,
- and VectorTools::project_boundary_values
,
+ and VectorTools::project_boundary_values
,
are now also implemented in 1d.
(WB 2001/04/29)
@@ -812,7 +813,7 @@ documentation, etc.
class="class">GridOut::write_ucd_faces
function are now also
1-based. This, to be consistent with the vertex numbers given
- by the GridOut
::GridOut
::write_ucd
function.
(RH 2001/04/20)
@@ -856,7 +857,7 @@ documentation, etc.
Fixed: When using Neuman boundary functions in the
- KellyErrorEstimator
class, it was
+ KellyErrorEstimator
class, it was
assumed that the function object had Function
::vector_value
overloaded, even
@@ -881,21 +882,21 @@ documentation, etc.
New: The following functions are extended to work
on arbitrary mappings:
- The static create_mass_matrix
,
- create_boundary_mass_matrix
and
- create_laplace_matrix
member
- functions of the class MatrixCreator
,
+ The static create_mass_matrix
,
+ create_boundary_mass_matrix
and
+ create_laplace_matrix
member
+ functions of the class MatrixCreator
,
- the static project
and project
and project_boundary_values
member functions
- of the class VectorTools
,
+ of the class VectorTools
,
the two versions of the static estimate
member functions of the class
- KellyErrorEstimator
,
+ KellyErrorEstimator
,
- and the static approximate_gradient
- and approximate_second_derivative
+ and the static approximate_gradient
+ and approximate_second_derivative
member functions of the class DerivativeApproximation
.
get_local_mass_matrix
function is now
removed. This was necessary as the local mass matrix depends not only on the
- considered FiniteElement
but also on
+ considered FiniteElement
but also on
the mapping between the unit to the real cell. Hence this function
cannot be a member function of a FiniteElement
any more.
@@ -936,7 +937,7 @@ documentation, etc.
one of the remaining MatrixCreator
::create_mass_matrix
functions that require
- an appropriate Quadrature
as
+ an appropriate Quadrature
as
argument.
Triangulation
::ExcMultiplySetLineInfoOfLine
exception,
- that is thrown if the SubCellData
+ that is thrown if the SubCellData
that is given to Triangulation
::create_triangulation
, multiply includes
the line info of a specific line. Before the fix the wrong
- ExcInteriorLineCantBeBoundary
+ ExcInteriorLineCantBeBoundary
exception was thrown.
- Removed: the ProblemBase
class,
+ Removed: the ProblemBase
class,
which has been deprecated since before the release of
- deal.II 3.0, has finally been removed. The
+ deal.II 3.0, has finally been removed. The
same applies for the classes
- Assembler
,
- Equation
,
- MassMatrix
, and
- LaplaceMatrix
.
+ Assembler
,
+ Equation
,
+ MassMatrix
, and
+ LaplaceMatrix
.
(WB 2001/03/27)
- New: There is now a class MappingC1
+ New: There is now a class MappingC1
that implements a continuously differentiable C1
mapping of the boundary by using a cubic mapping with
continuous derivatives at cell boundaries. The class presently
@@ -1003,14 +1004,14 @@ documentation, etc.
- New: The static interpolate
, interpolate
, create_right_hand_side
, interpolate_boundary_values
, integrate_difference
and compute_mean_value
member functions of
- the class VectorTools
are extended
+ the class VectorTools
are extended
to work on arbitrary mappings. All these functions now take a
- Mapping
object as additional
+ Mapping
object as additional
argument.
For backward compatibility there exist second versions of
@@ -1023,7 +1024,7 @@ documentation, etc.
- New: Boundary
and derived classes
+ New: Boundary
and derived classes
now have a function get_normals_at_vertices
that returns a
multiple of the normal vector to the boundary at the
@@ -1055,7 +1056,7 @@ documentation, etc.
- New: GridGenerator
::GridGenerator
::hyper_rectangle
creates
coordinate-parallel rectangles in arbitrary dimension.
@@ -1081,10 +1082,10 @@ documentation, etc.
Removed: The function FiniteElement<dim>
::get_support_points
- is removed as the FiniteElement
+ is removed as the FiniteElement
cannot know the position of the support points by itself. This is
because the support points depend on the unit support points
- (known to the FiniteElement
class)
+ (known to the FiniteElement
class)
but they also depend on the mapping.
In future the support points can be computed using a .
- New: The class Boundary
has two new
+ New: The class Boundary
has two new
functions get_intermediate_points_on_line
and get_intermediate_points_on_quad
that
@@ -1113,19 +1114,19 @@ documentation, etc.
New: The functions GridOut::write_gnuplot
and GridOut::write_eps
now take a pointer to
- a Mapping
object as additional
+ a Mapping
object as additional
argument. This allows to write grids in 2d whereby cells with a
curved boundary are transformed by the given Mapping
class. The default mapping is
- MappingQ1
. Note, that the grids do
+ MappingQ1
. Note, that the grids do
not show the `original' domain with boundaries described by the
- Boundary
classes but the
+ Boundary
classes but the
discretized domain whose boundary cells are transformed using the
given mapping.
GnuplotFlags::n_boundary_face_points
and
- EpsFlags::n_boundary_face_points
+ EpsFlags::n_boundary_face_points
variables to set the number of additional points written
to represent the curved boundary faces.
- New: The constructor of the FEValues
- and FE(Sub)FaceValues
classes now
- take a reference of a Mapping
object
+ New: The constructor of the FEValues
+ and FE(Sub)FaceValues
classes now
+ take a reference of a Mapping
object
as additional argument. This is the new possibility to combine
- a FiniteElement
with an arbitrary
- Mapping
, see also FiniteElement with an arbitrary
+ Mapping
, see also New FE and Mapping Design.
For backward compatibility there still exists a constructor of
- FEValues
without a FEValues
without a Mapping
argument that uses a MappingQ1
by default.
@@ -1165,7 +1166,7 @@ documentation, etc.
- New: The class GridReordering::Cell
has
+ New: The class GridReordering::Cell
has
now a copy constructor to work around a bug in a gcc3.0
snapshot.
@@ -1206,8 +1207,8 @@ documentation, etc.
- New: The DoFTools
class now has
- a function count_dofs_per_component
+ New: The DoFTools
class now has
+ a function count_dofs_per_component
that counts the number of degrees of freedom in each of the
components of the finite element, i.e. how many degrees of
freedom there are on the global mesh for each variable (field).
@@ -1216,13 +1217,13 @@ documentation, etc.
- New: The CellAccessor
class now has a function
- has_boundary_lines
that mostly has
- the same semantics that at_boundary
+ New: The CellAccessor
class now has a function
+ has_boundary_lines
that mostly has
+ the same semantics that at_boundary
has, but also covers the case that a hexahedron in 3d may be at
the boundary only by one line, rather than by a whole face. In
- that case, at_boundary
reports
- false, while has_boundary_lines
+ that case, at_boundary
reports
+ false, while has_boundary_lines
reports true.
(WB 2001/02/21)
@@ -1230,7 +1231,7 @@ documentation, etc.
New: There is now a function
- ConstraintMatrix
::ConstraintMatrix
::merge
that merges
the constraints represented by two constraint matrices into one
object.
@@ -1239,8 +1240,4 @@ documentation, etc.
+This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author. +
+ +
+ The only is change is that the configuration detects the
+ presence of gcc3.0 and works around a bug in it by compiling
+ the file tria_accessor.cc(3d)
without optimization
+ flags even for optimized libraries. The gcc bug is documented
+ at the gcc bug tracking system page, as bugs reports c++/615 and
+ optimization/2938.
+
+ (WB 2001/06/27)
+
+This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author. +
- Fixed: In the ParameterHandler
+ Fixed: In the ParameterHandler
class, we leaked 8 or 12 bytes of memory per declared
parameter. This is now fixed.
@@ -22,7 +35,7 @@
- Fixed: he DoFHandler
class had a
+ Fixed: he DoFHandler
class had a
memory leak. This is now fixed.
(WB 2001/11/28)
@@ -52,7 +65,7 @@
Fixed: when checking for convergence in linear solvers in
- SolverControl::check
, we first
+ SolverControl::check
, we first
checked whether the maximal iteration count was reached, and
only then whether the target residual was achieved. In cases,
where the target residual was only reached in the very last
@@ -95,7 +108,7 @@
- Fixed: class SparsityPattern
can
+ Fixed: class SparsityPattern
can
handle rows of length zero now. For quadratic matrices, these
rows are changed to length one, since a diagonal element must
be stored.
@@ -104,10 +117,10 @@
- Fixed: The DataOutBase::EpsFlags
+ Fixed: The DataOutBase::EpsFlags
class forgot to declare the reverse grey scale function as one
possible input for the color function for the
- ParameterHandler
class. This is now
+ ParameterHandler
class. This is now
possible.
(WB 2001/10/10)
@@ -122,8 +135,4 @@
+This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author. +
@@ -89,7 +92,7 @@ documentation, etc.
- New: deal.II now uses a file
+ New: deal.II now uses a file
config.h
for most global preprocessor defines,
instead of an overly long list of compiler flags given on the
command line.
@@ -99,9 +102,9 @@ documentation, etc.
Changed: If available, the library now uses the C++ standard
- classes istringstream
and istringstream
and ostringstream
over the old classes
- i/ostrstream
. The ./configure script
+ i/ostrstream
. The ./configure script
finds out whether the new classes exist, or whether the
backward compatibility classes are to be used.
@@ -171,15 +174,15 @@ documentation, etc.
aborted the program. In that case only report the error and
write out an indication why we do not abort the program any
more. On the other hand, also suppress output of further failed
- Assert()
calls, since they often
+ Assert()
calls, since they often
are follow-ups of the first one.
(WB 2002/01/09)
- New: ExcFileNotOpen
can be used
- after initializing an fstream
+ New: ExcFileNotOpen
can be used
+ after initializing an fstream
object. This allows to avoid some cryptic ExcIO
s.
@@ -187,15 +190,15 @@ documentation, etc.
- Changed: The OutputStyle
enum used
+ Changed: The OutputStyle
enum used
to indicate the output format has been moved into the
- ParameterHandler
class.
+ ParameterHandler
class.
(WB 2001/11/30)
- Fixed: In the ParameterHandler
+ Fixed: In the ParameterHandler
class, we leaked 8 or 12 bytes of memory per declared
parameter. This is now fixed.
@@ -203,9 +206,9 @@ documentation, etc.
- New: Functions::CutOffFunctionCinfty
,
- Functions::CutOffFunctionW1
, and
- Functions::CutOffFunctionLinfty
+ New: Functions::CutOffFunctionCinfty
,
+ Functions::CutOffFunctionW1
, and
+ Functions::CutOffFunctionLinfty
implement functions with support in an arbitrary ball and
differentiability as indicated by their name
@@ -213,10 +216,10 @@ documentation, etc.
- Fixed: The DataOutBase::EpsFlags
+ Fixed: The DataOutBase::EpsFlags
class forgot to declare the reverse grey scale function as one
possible input for the color function for the
- ParameterHandler
class. This is now
+ ParameterHandler
class. This is now
possible.
(WB 2001/10/10)
@@ -256,8 +259,8 @@ documentation, etc.
- Improved: reinit function of Vector
- and BlockVector
allows use of a
+ Improved: reinit function of Vector
+ and BlockVector
allows use of a
vector with different number type.
(GK 2001/11/21)
@@ -265,7 +268,7 @@ documentation, etc.
Fixed: when checking for convergence in linear solvers in
- SolverControl::check
, we first
+ SolverControl::check
, we first
checked whether the maximal iteration count was reached, and
only then whether the target residual was achieved. In cases,
where the target residual was only reached in the very last
@@ -276,7 +279,7 @@ documentation, etc.
- New: the SparseDirectMA27/47
classes
+ New: the SparseDirectMA27/47
classes
now provide access to Mutex locks for external
synchronisation.
@@ -300,15 +303,15 @@ documentation, etc.
- Improved: class SolverGMRES
accepts
- a parameter in AdditionalData
,
+ Improved: class SolverGMRES
accepts
+ a parameter in AdditionalData
,
allowing for right preconditioning.
(GK 2001/11/09)
- Fixed: class SparsityPattern
can
+ Fixed: class SparsityPattern
can
handle rows of length zero now. For quadratic matrices, these
rows are changed to length one, since a diagonal element must
be stored.
@@ -317,14 +320,14 @@ documentation, etc.
- New: The BlockVector
now has a
+ New: The BlockVector
now has a
full-fledged random access iterator type, working in exactly
the same way as the iterators of the C++ standard containers.
(WB 2001/09/28)
New: New:
- Changed: The classes Vector
::
Vector
::operator *
is now templatized, allowing
for scalar products of vectors with different underlying types.
@@ -339,22 +342,22 @@ documentation, etc.
FEQ1
-FEQ1
-FEQ4
, FEDG_Q1
FEDG_Q4
+ class="class">FEDG_Q1FEDG_Q4
as well as the files with their definitions,
fe/fe_lib.lagrange.h and fe/fe_lib.dg.h
ceased to exist. They had been left in for backward
compatibility in an earlier version, but their existence is
more confusing than helpful. Please change your code to use the
- classes FE_Q
and FE_Q
and FE_DGQ
, respectively.
(GK 2002/02/01)
- New: The FilteredIterator
class
+ New: The FilteredIterator
class
provides a view on ranges of iterators by iterating over only
those objects that satisfy a certain predicate.
@@ -363,7 +366,7 @@ documentation, etc.
Improved: It is now possible to read in unconnected domains
- through the GridIn
class, since
+ through the GridIn
class, since
renumbering the cells now also works for these domains.
(Michael Stadler 2001/12/14)
@@ -374,14 +377,14 @@ documentation, etc.
class="class">VectorTools::compute_mean_value
take ingoing and
outgoing vector types as template arguments. This allows
- applying them to BlockVector
.
+ applying them to BlockVector
.
(GK 2001/12/07)
- New: GridGenerator
has a function
- cylinder
for cylinders in three
+ New: GridGenerator
has a function
+ cylinder
for cylinders in three
space dimensions. Accoridngly, a class CylinderBoundary
has been created.
@@ -389,7 +392,7 @@ documentation, etc.
- New: FiniteElement
::FiniteElement
::has_support_on_face
allows to check
whether a shape function has non-zero values on a certain face
of a cell.
@@ -398,7 +401,7 @@ documentation, etc.
- Changed: The IteratorState
enum used
+ Changed: The IteratorState
enum used
to indicate the state in which an iterator can be is now
enclosed in a namespace of the same name, to take its members
out of the global namespace. When using one of these members,
@@ -409,11 +412,11 @@ documentation, etc.
- Changed: The NormType
enum used to
+ Changed: The NormType
enum used to
indicate the norm the VectorTools::integrate_difference
function shall integrate is moved from the global namespace
- into the VectorTools
class. You
+ into the VectorTools
class. You
therefore have to prefix the members of this enum by the
respective class name.
@@ -429,7 +432,7 @@ documentation, etc.
- Fixed: The DoFHandler
class had a
+ Fixed: The DoFHandler
class had a
memory leak. This is now fixed. Likewise for the MGDoFHandler
class.
@@ -485,7 +488,7 @@ documentation, etc.
subdomain_id which can be used in parallel
computations to identify which cells are handled on which
processor. These flags are read and set using the functions
- cell->subdomain_id()
and cell->subdomain_id()
and cell->set_subdomain_id(new_id)
. The
subdomain ids are unsigned integers, so should be sufficiently
large also for larger numbers of subdomains.
@@ -515,7 +518,7 @@ documentation, etc.
class="class">VectorTools::integrate_difference
take ingoing and
outgoing vector types as template arguments. This allows
- applying them to BlockVector
and of
+ applying them to BlockVector
and of
outputting a vector of doubles suitable for DataOut
.
@@ -524,7 +527,7 @@ documentation, etc.
Fixed: Functions creating sparsity patterns for DG elements in
- DoFTools
get the pattern type as
+ DoFTools
get the pattern type as
template argument, too..
(GK 2001/10/01)
@@ -538,8 +541,4 @@ documentation, etc.
+This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author. +
+ + +
+ Fixed: In 3d, the function DoFTools::make_hanging_node_constraints
+ contained an assertion that failed erroneously for finite
+ elements that do not have degrees of freedom on vertices. This
+ is now fixed.
+
+ (WB 2002/02/21)
+
+ Fixed: TriaAccessor<3,3>::measure
+ sometimes computed a negative value. This is now fixed.
+
+ (WB 2002/02/21)
+
-This is a quite extensive list of changes made between versions 3.3.0 -and 3.4.0 of deal.II. 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. +This is the list of changes made between the deal.II releases listed above. +All entries are signed with the names of the author.
--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), BK (Benjamin S. Kirk). -
- -
- New: In all previous versions, deal.II used
+ New: In all previous versions, deal.II used
the ACE (Adaptive Communications Environment)
library to support cross-platform threading
@@ -129,7 +123,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Fixed: For gcc versions that used ostrstream
instead of ostringstream
, it was necessary to append
- a final std::ends
when piping text
+ a final std::ends
when piping text
into the string stream. This was not previously
conditionalized, but done for old and new classes.
@@ -171,9 +165,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The vector2d
row accessor
+ New: The vector2d
row accessor
classes now have member functions begin
and end
+ class="member">begin and end
which allow iterating over the elements of a row of such an
object.
@@ -181,8 +175,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The Legendre
and
- LagrangeEquidistant
classes now have
+ New: The Legendre
and
+ LagrangeEquidistant
classes now have
static member functions generate_complete_basis
which returns an
array of polynomial objects spanning the complete space up to a
@@ -193,8 +187,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Changed: The Polynomial
and
- LagrangeEquidistant
classes have lost
+ Changed: The Polynomial
and
+ LagrangeEquidistant
classes have lost
their default constructor, as that did not make much sense
anyway.
@@ -211,9 +205,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: The class TensorFunction
- now uses local types value_type
and
- gradient_type
as return values of
+ Fixed: The class TensorFunction
+ now uses local types value_type
and
+ gradient_type
as return values of
its member functions. This works around a bug in Sun's Forte
C++ compilers.
@@ -221,8 +215,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Improved: The AssertThrow
macro now
- uses __builtin_expect
if the
+ Improved: The AssertThrow
macro now
+ uses __builtin_expect
if the
compiler supports this. This indicates to the compiler that we
expect the condition to be true and that throwing an exception
is a rare case. By this information, the compiler can help the
@@ -233,19 +227,19 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The vector2d
class now not only
+ New: The vector2d
class now not only
allows access to elements through the operator()(unsingned int,unsigned int)
(i.e. matrix or Fortran style access), but also through nested
- brackets via an operator[]
+ brackets via an operator[]
(i.e. like to a two-dimensional C-style array).
(WB 2002/03/08)
- Changed: The function MultithreadInfo
::
- get_n_cpus
now reports the proper number
+ Changed: The function MultithreadInfo
::
+ get_n_cpus
now reports the proper number
of CPUs when running on Silicon Graphics.
(BK 2002/02/19)
@@ -255,14 +249,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Changed: The quite logorrhoeic function name TensorProductPolynomials
::n_tensor_product_polynomials
was changed to
- n
to be compliant wth the new class n
to be compliant wth the new class PolynomialSpace
.
(GK 2002/02/11)
- New: The class PolynomialSpace
+ New: The class PolynomialSpace
implements the space of polynomials at most a certain degree in
arbitrary space dimensions.
@@ -270,8 +264,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The function DataOutBase
::
- write_tecplot_binary
has been
+ New: The function DataOutBase
::
+ write_tecplot_binary
has been
added. This function will write Tecplot binary files if the
Tecplot API is detected by ./configure. To use this feature be
sure that the environment variable TECHOME points to a valid
@@ -294,7 +288,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Improved: SolverGMRES
allocates
+
Improved: SolverGMRES
allocates
basis vectors only, when they are needed. Therefore, it is safe
now to ask for a basis larger than the expected number of
iteration steps. On the other hand, memory allocation failures
@@ -329,9 +323,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The GeometryInfo
class now
+ New: The GeometryInfo
class now
provides two methods,
- unit_cell_vertex
and unit_cell_vertex
and vertices_adjacent_to_line
, that reveal
something about the placement and numbering of vertices on the
uni cell.
@@ -340,8 +334,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The GridOut::
- write_dx
function is now implemented.
+ New: The GridOut::
+ write_dx
function is now implemented.
It allows to write the mesh (cells and faces) with some additional
information that may be useful once in a while.
@@ -349,7 +343,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: The IteratorState::IteratorState
+ Fixed: The IteratorState::IteratorState
enum is now called IteratorState::IteratorStates
. This works
around a bug in Sun's Forte C++ compilers which can't handle
@@ -370,7 +364,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: TriaAccessor<3,3>::measure
+ Fixed: TriaAccessor<3,3>::measure
sometimes computed a negative value. This is now fixed.
(WB 2002/02/21)
@@ -378,14 +372,10 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: Finite element family with complete polynomial spaces
- for discontinuous Galerkin: FE_DGP
+ for discontinuous Galerkin: FE_DGP
(GK 2002/02/11)
-This is the list of changes made after the release of -deal.II version 3.4. 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. -
+// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2013, 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + +/** + * @page changes_between_3_4_and_4_0 Changes between Version 3.4 and 4.0+This is the list of changes made between the deal.II releases listed above. 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). @@ -33,7 +30,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: deal.II now uses a new threading + New: deal.II now uses a new threading scheme. The new scheme is simpler to use, and in particular more flexible in some cases where only one thread is started, or where a thread is completely detached, since we got rid of @@ -55,7 +52,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: deal.II now makes use of some parts of + New: deal.II now makes use of some parts of the boost library, which is supposed to be a testground for the next generation C++ standard library. The parts which we use are now in @@ -88,7 +85,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Changed: Classes and structures that are declared inside namespaces named
- internal
are now no longer shown in the class
+ internal
are now no longer shown in the class
index view of the documentation of each of the sublibraries. Since they
are supposed to be used internally only, this is no drawback for the
general public. However, they are documented as members of these
@@ -115,7 +112,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: Changes have been made to support compiling and using
- deal.II on AIX 5 systems.
+ deal.II on AIX 5 systems.
(WB 2003/01/24)
- New: deal.II can be compiled with version 7.0 of
+ New: deal.II can be compiled with version 7.0 of
Intel's icc compiler, which was recently released. Since this compiler
finally supports the very restrictive flags -Xc -ansi
that
check for close conformance with the C++ standard, we use them (previous
@@ -186,7 +183,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: deal.II can now also be compiled with Red Hat's
+ New: deal.II can now also be compiled with Red Hat's
version of the gcc compiler, gcc 2.96. However, some problems remain;
for more information.
@@ -215,7 +212,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
M_PI
and M_E
) when certain defines are set (on
Linux, these are __USE_BSD
or __USE_XOPEN
),
portable programs usually defined these constants themselves. In
- deal.II, this happened at 6 different places. To
+ deal.II, this happened at 6 different places. To
avoid this in the future, base/config.h
now exports a
namespace deal_II_numbers
that defines these two, and a
number of other numerical constants.
@@ -225,7 +222,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: base/config.h
now exports the
- deal.II base directory through the
+ deal.II base directory through the
DEAL_II_PATH
preprocessor variable.
(WB 2002/09/09)
@@ -291,7 +288,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: deal.II now also supports vector-valued
+ New: deal.II now also supports vector-valued
finite elements with shape functions for which more than just
one vector component is non-zero. Such elements are, for
example, the Nedelec and Raviart-Thomas families. Previously,
@@ -307,7 +304,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: The top-level makefile now how a target distclean.
clean leaves the libraries now, removing
everything that is not needed to use
- deal.II. distclean removes even the
+ deal.II. distclean removes even the
libraries, leaving the directory more or less in the state like
after configure.
@@ -329,7 +326,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Changed: The Polynomials::Legendre
+ Changed: The Polynomials::Legendre
class lost its template argument and is now just a regular
class. There was no real good reason for the template argument,
it had just crept in.
@@ -347,7 +344,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Changed: The Table
accessor classes
+ Changed: The Table
accessor classes
have been moved to a namespace internal
. Since these classes are not (or should
not be) used directly in applications, this should not change
@@ -358,7 +355,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The Function
class now has an assignment
+ New: The Function
class now has an assignment
operator. This way, you can put function objects into
containers. However, the assignment operator makes sure that only
objects can be assigned that have the same number of vector components.
@@ -367,8 +364,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- New: The ThreadMutex
classes now have a
- member class ScopedLock
that implements the
+ New: The ThreadMutex
classes now have a
+ member class ScopedLock
that implements the
scoped thread-safe locking pattern of Doug Schmidt. It is also used in
various places of the code now.
@@ -376,8 +373,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: The
- Fixed: The
- New: There are now classes
- New: There is now a
Changed: In POSIX mode, when the
- Fixed: The Changed: Because they became too many, the classes describing 1d
- polynomials are now in a Changed: The class
- New: The
- New: The old class
- New: Row accessors for the
New: There are now operators to allow multiplication and
- division of New: Function
- New: Functions New: Functions Deprecated: The functions Deprecated: The functions New: New: New: New: New: New: New: New: Improved: Improved:
- New/Changed: The
- Changed: The
- New: The
- New:
Changed: In an attempt to unify the use of preconditioners a
- little, the function
- Fixed: In the New: Class New: Class New: Class New: Class
- New: Classes
- New:
New: a way of using abstract base classes for matrices has
- been implemented with
- New: The
New: The functions in the
- New: The
- Fixed: The
- Fixed: The
- New: The
- New: The
Changed: Some implementation details of the
New: There are now functions
- Fixed: Objects of type
New: For each of the renumbering functions in the
- Fixed: The
- Changed: The
- New: Checked in new
- New: Checked in new class
New: For finite element classes, the functions
-
Fixed: Vectors could not be given as input and output vectors to the
-
New: The
Fixed: The algorithm to generate neighbor information for patches from
- cells in
- Fixed: the
- Improved: New: The New: The Changed: The constructor of
- Fixed: The
New: For encapsulated postscript output of 2d grids, it is now
- possible to tell the
-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.
-
+This is the list of changes made between the deal.II releases listed above.
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).
@@ -42,101 +39,82 @@ inconvenience this causes.
Removed: All the matrix classes have functions Removed: All the matrix classes have functions PosixThreadManager
called
- its wait
function in the
+ Fixed: The PosixThreadManager
called
+ its wait
function in the
destructor. If this had been called before already, then the
same threads would have been waited for twice, which invokes
undefined behavior. This is fixed by making sure that
function has therefore been removed to
- avoid confusion with the Subscriptor
uses a counter to
- count how many SmartPointer
objects subscribe
+ Fixed: The Subscriptor
uses a counter to
+ count how many SmartPointer
objects subscribe
to the pointed-to object. This counter needs to be a volatile variable
in multithreaded mode, to avoid false compiler optimizations based on
the assumption that the variable cannot change between two subsequent
@@ -413,7 +410,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
ThreadCondition
+ New: There are now classes ThreadCondition
that implement thread condition variable operations through POSIX
functions (in multithreaded mode) or doing nothing (in singlethreaded
mode).
@@ -436,7 +433,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Patterns::List
pattern
+ New: There is now a Patterns::List
pattern
that matches a list of elements each of which has to satisfy a pattern
that was given to the constructor.
@@ -446,9 +443,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
ThreadManager
class created a new thread through
- pthread_create
, it only checked for the
+ pthread_create
, it only checked for the
error code and aborted if it was non-zero. Now, it checks whether the
- error code is EAGAIN
and simply retries the
+ error code is EAGAIN
and simply retries the
call if this is the case. This may, in rare cases, lead to a deadlock or
an infinite loop, but will usually just wait until the respective
resources for thread creation are available from the operating system
@@ -458,7 +455,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
write_text
and write_text
and write_tex
functions of the TableHandler
class now check whether their
ofstream
arguments are in a proper state before
@@ -476,7 +473,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
namespace
+ polynomials are now in a
namespace
Polynomials
.
(WB 2002/10/14)
@@ -487,7 +484,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
system. Rather, if the exception is not caught from the function that
was invoked by the spawning system function, the entire program is
terminated without an additional message. The wrapper functions which
- are used to spawn new threads in the Threads
+ are used to spawn new threads in the Threads
namespace therefore now catch these exceptions and at least print the
message they carry, before aborting the program. This way, at least the
message gets displayed.
@@ -497,7 +494,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Table<2>::fill
function, which is also
- inherited from the FullMatrix
class, used to
+ inherited from the FullMatrix
class, used to
work also when the size of the matrix was zero, by simply not copying
something. This led to difficult to detect errors. It is therefore no
more allowed to call this function when the matrix is empty. For all
@@ -520,7 +517,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Threads::n_existing_threads
+ New: The Threads::n_existing_threads
function returns the present number of existing threads, allowing an
assessment whether it is useful to spawn new threads or rather perform
the operation in question sequentially.
@@ -550,14 +547,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
vector2d
, implementing a
+ New: The old class vector2d
, implementing a
two-dimensional array of objects is now gone. Instead, there is the new
- Table
class that implements tables of
+ Table
class that implements tables of
arbitrary dimension. Transition is painless: where there was
vector2d<type>
before, use
Table<2,type>
now (and don't forget to update the
name of the header file, of course). If you have a three-dimensional
- array, you can use Table<3,type>
now.
+ array, you can use Table<3,type>
now.
(WB 2002/09/03)
vector2d
+ New: Row accessors for the vector2d
class now have a member function size
that returns the size of the row,
i.e. the number of columns of the table.
@@ -598,7 +595,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Tensor
objects by scalar
+ division of Tensor
objects by scalar
factors.
(WB 2002/06/07)
@@ -612,39 +609,39 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
-BlockSparseMatrix::print_formatted
+ BlockSparseMatrix::print_formatted
added, similar to the
- BlockVector::print_formatted
function.
+ BlockVector::print_formatted
function.
(Brian Carnes 2003/06/02)
SparseMatrix::operator *=
- and SparseMatrix::operator /=
as well as
- BlockSparseMatrix::operator *=
- and BlockSparseMatrix::operator /=
+ SparseMatrix::operator *=
+ and SparseMatrix::operator /=
as well as
+ BlockSparseMatrix::operator *=
+ and BlockSparseMatrix::operator /=
are added.
(Brian Carnes 2003/06/02)
Vector::scale
- and BlockVector::scale
are now deprecated
+ Vector::scale
+ and BlockVector::scale
are now deprecated
and will be removed in a future version. Use operator*=
and
operator/=
instead.
(WB 2003/05/31)
Vector
,
Vector
, BlockVector
and
- FullMatrix
now have operator/=
+ FullMatrix
now have operator/=
for scaling by a scalar.
(WB 2003/05/31)
PointerMatrix
now
+ PointerMatrix
now
has empty()
function, which returns true if the pointer is
null; otherwise we call the pointer's empty()
function.
This requires the class MATRIX to have an empty()
@@ -653,21 +650,21 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(Brian Carnes 2003/05/22)
SparseLUDecomposition
now
+ SparseLUDecomposition
now
has empty()
function, which calls the inherited SparseMatrix
empty()
function.
(Brian Carnes 2003/05/22)
PreconditionPSOR
implements
+ PreconditionPSOR
implements
interface to permuted SOR preconditioner function in SparseMatrix
.
(GK 2003/05/12)
FullMatrix
::
FullMatrix
::fill
now copies the largest possible block,
whether the destination or source matrix is bigger. Additionally, an
offset inside the source matrix may be specified.
@@ -676,12 +673,12 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
SparseILU
, SparseILU
, SparseMIC
and SparseLUDecomposition
now use the same
- interface (initialize
, vmult
, clear
)
- as all PreconditionBlock
classes. In
+ interface (initialize
, vmult
, clear
)
+ as all PreconditionBlock
classes. In
virtue of an unified preconditioner interface it is now
recommended to use the new methods. The old methods (reinit
,
BlockVector
accessor classes
+ Changed: The BlockVector
accessor classes
have been moved to a namespace internal
. Since these classes are not (or should
not be) used directly in applications, this should not change
@@ -704,8 +701,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
SolverGMRES
now accepts an
- AdditionalData
parameter
+ New: The SolverGMRES
now accepts an
+ AdditionalData
parameter
use_default_residual
whose default is
true
. By setting this flag to false
,
the stopping criterion of the left-preconditioned GMRes solver
@@ -719,7 +716,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FullMatrix
has a function FullMatrix
has a function copy_from
, copying from sparse matrices.
It uses iterators of the sparse matrix classes.
@@ -729,10 +726,10 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
initialize
of
- classes PreconditionRelaxation
and
- PreconditionBlock
take an argument
- of type AdditionalData
, defined in
+ little, the function initialize
of
+ classes PreconditionRelaxation
and
+ PreconditionBlock
take an argument
+ of type AdditionalData
, defined in
the same class. Standard behavior of PreconditionBlock
has been changed on this
occasion to invert diagonal blocks during initialization.
@@ -763,7 +760,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
SparseDirectMA27
class, wrapping
+ Fixed: In the SparseDirectMA27
class, wrapping
the MA27 solver written in Fortran77 into some structure amenable to C++,
we wrote beyond the end of an array on rare inputs. This is now fixed. The
same probably holds for the respective code for MA47.
@@ -775,13 +772,13 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: Since the MA27 sparse direct solver uses Fortran common blocks, it
was previously impossible to run several instances of this solver in
parallel, in a multihreaded environment. To solve this problem, the
- SparseDirectMA27
class now has a detached
+ SparseDirectMA27
class now has a detached
mode, in which it forks off a separate program that will do the
computations using this solver. The actual operations are therefore
distributed to distint programs that have separate address spaces. This
allows to have as many concurrent instances of this solver in parallel
as you want. For more information, read the documentation of the
- SparseDirectMA27
class.
+ SparseDirectMA27
class.
(WB 2002/09/25)
BlockVector
has a
- function collect_sizes()
, very much as
- BlockSparsityPattern
. This allows
+ BlockVector
has a
+ function collect_sizes()
, very much as
+ BlockSparsityPattern
. This allows
updating internal structures after blocks have been resized.
(GK 2002/09/17)
SparseMatrix
has an
- STL-conforming const_iterator
and
- functions begin()
and
, SparseMatrix
has an
+ STL-conforming const_iterator
and
+ functions begin()
and end()
for looping through all existing
- entries. Furthermore, begin(row)
and
- end(row)
allow looping through all
+ entries. Furthermore, begin(row)
and
+ end(row)
allow looping through all
entries of a single line.
(GK 2002/09/11)
SparsityPattern
and SparsityPattern
and SparseMatrix
now have functions block_write/block_read
, allowing to dump the data
of these objects into a file in binary format, and later to re-read it
@@ -827,7 +824,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Vector
has a function Vector
has a function lp_norm
, computing the lp-norm
of a vector for arbitrary p.
@@ -836,9 +833,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
PointerMatrixBase
- and PointerMatrix
. Storing a matrix in
- PointerMatrix
allows to use the base
+ been implemented with PointerMatrixBase
+ and PointerMatrix
. Storing a matrix in
+ PointerMatrix
allows to use the base
class in functions only templated for the vector class.
(GK 2002/07/18)
@@ -862,7 +859,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GeometryInfo
classes now
+ New: The GeometryInfo
classes now
have new static member functions child_cell_from_point
that, given a point
in the unit cell, returns which child cell it is on;
DerivativeApproximation
class can now also
- work on BlockVector
.
+ work on BlockVector
.
(WB 2003/04/11)
DataOut_DoFData::merge_patches
+ New: The DataOut_DoFData::merge_patches
function allows to merge the patches of two objects, so as to create one
output file from several DoF handlers. This is useful if one uses a
domain decomposition algorithm where each block of the domain is
@@ -924,7 +921,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
DataOutStack
class had a problem
+ Fixed: The DataOutStack
class had a problem
when there were as many degrees of freedom as there were cells (i.e. if
we were using DG0 elements). This should now be fixed.
@@ -932,7 +929,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
DataOutFaces
class was
+ Fixed: The DataOutFaces
class was
broken for cell data. It should now be correct, although the
algorithm used is not optimal, being approximately quadratic in
runtime.
@@ -941,7 +938,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
ConstraintMatrix::shift
+ New: The ConstraintMatrix::shift
function shifts and translates the elements of the constraint
matrix by a certain number of indices.
@@ -949,7 +946,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GridReordering
class now uses a
+ New: The GridReordering
class now uses a
vastly better algorithm in 2d than previously. The new algorithm is
linear in time, where it could be exponential before.
@@ -967,7 +964,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GridReordering
class have been moved to a
- namespace internal
.
+ namespace internal
.
(WB 2003/02/19)
FiniteElement::prolongation_is_implemented
and
- FiniteElement::constraints_are_implemented
+ FiniteElement::constraints_are_implemented
that inform the caller about whether the finite element in question in
fact implements its prolongation matrices and hanging node constraints.
@@ -993,7 +990,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FESystem
+ Fixed: Objects of type FESystem
could not be constructed if one of the elements it is to be composed of
did not implement interface constraints for hanging nodes. This is now
fixed: you can construct such a composed element, but it does not
@@ -1005,17 +1002,17 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
DoFRenumbering
class there is now an
- additional compute_*
+ additional compute_*
function. These new functions compute and return the
corresponding renumbering vectors but do not perform the actual
- renumbering on the DoFHandler
+ renumbering on the DoFHandler
object. The behaviour of the old functions is not changed.
(RH 2003/02/03)
GridReordering
tried to be
+ Fixed: The GridReordering
tried to be
thread-safe in the initialization of some data, but was not due to a
typo. This is now fixed.
@@ -1023,8 +1020,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FEValues::get_cell
and
- FEValues::get_face
functions have
+ Changed: The FEValues::get_cell
and
+ FEValues::get_face
functions have
been removed, since they limited our ability to use this
class for other types of DoFHandlers, for example future
extensions for hp elements.
@@ -1044,21 +1041,21 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GridGenerator
- member function half_hyper_ball
,
- derived from member hyper_ball
.
+ New: Checked in new GridGenerator
+ member function half_hyper_ball
,
+ derived from member hyper_ball
.
The initial mesh contains four elements. This mesh will work with
- the boundary class HalfHyperBallBoundary
.
+ the boundary class HalfHyperBallBoundary
.
(Brian Carnes 2002/12/16)
FE_Q_Hierarchical
- derived from class FiniteElement
.
- This element is analogous to FE_Q
, but
+ New: Checked in new class FE_Q_Hierarchical
+ derived from class FiniteElement
.
+ This element is analogous to FE_Q
, but
makes use of hierarchical shape functions, based on the
- Polynomials::Hierarchical
class.
+ Polynomials::Hierarchical
class.
For degree>1
, the non-nodal basis functions are "bubble"
functions, which are not Lagrange polynomials. Therefore, the usual
interpolation based on using unit support points will not work for
@@ -1074,20 +1071,20 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
unit_support_point
and
- unit_face_support_point
return the position
+ unit_support_point
and
+ unit_face_support_point
return the position
of an individual support point. This is necessary when you want to get
information about the support points of certain components in a composed
finite element, where not all components provide support points, and the
composed element thus does not fill the array the
- get_unit_support_points
function returns.
+ get_unit_support_points
function returns.
(WB 2002/11/23)
SolutionTransfer
class at the same time, but
+ SolutionTransfer
class at the same time, but
this was not checked. An assertion has now been added to ensure this
requirement.
@@ -1118,7 +1115,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
FiniteElement::element_multiplicity
function was
- previously only available in the FESystem
+ previously only available in the FESystem
class, where it actually returned a non-trivial value. However, in some
cases one would need to access this field also for general finite
elements, even if the returned value will be equal to one in all cases
@@ -1129,7 +1126,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
DataOut::build_patches
was rather
+ cells in DataOut::build_patches
was rather
inefficient, tripling the time for patch generation when support for
neighbor information was added. Furthermore, the algorithm was at least
O(N log N), where the rest was all O(N), making this particularly
@@ -1213,7 +1210,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GridIn
class had problems
+ Fixed: the GridIn
class had problems
when reading in UCD grids with comment lines that contained
only the comment sign, but nothing else. This is now fixed.
@@ -1221,7 +1218,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
VectorTools
::VectorTools
::integrate_difference
can compute Lp
and W1,p norms for arbitrary p. The function
receives an additional optional argument p for this. All previous
@@ -1230,7 +1227,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(GK 2002/08/01)
GridTools
class now
+ GridTools
class now
offers functions to apply general transformations to all
vertices of a triangulation, and also more specialized
functions that shift, scale, and rotate triangulations.
@@ -1244,7 +1241,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
for continuous elements on globally refined grids and on
discontinuous elements, only. Now, there is a new FETools::extrapolate
function with an
- additional ConstraintMatrix
argument
+ additional ConstraintMatrix
argument
for the hanging node constraints. This new function works for
continuous as well as for discontinuous elements. But, the old
function is still supported.
@@ -1295,7 +1292,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
led to unexpected behaviour of the user_flags
for users who weren't aware of
this side-effect. Now, these functions do not alter
- the user_flags
, any
+ the user_flags
, any
more. Consequently, the users do not need to worry any more
about the reliability of the user_flags
when calling any function of
@@ -1333,7 +1330,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
DoFHandler
now takes a reference to a
- const
Triangulation
.
+ const
Triangulation
.
(RH 2002/06/12)
TriaAccessor
and TriaIterator
classes now take pointers to
- const Triangulation
s.
+ const Triangulation
s.
(RH 2002/06/12)
get_dof_indices
+ Fixed: The get_dof_indices
functions of DoF accessor classes used to work also for
non-active cells. However, the results were bogus except for
the special case that we had a finite element that has all its
@@ -1370,7 +1367,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GridOut
class to
+ possible to tell the GridOut
class to
write the cell numbers into each cell, as well as the numbers
of the vertices.
@@ -1378,8 +1375,5 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
-Last update $Date$
-
-
+*/
diff --git a/doc/news/4.0.0-vs-5.0.0.html b/doc/news/4.0.0-vs-5.0.0.h
similarity index 61%
rename from doc/news/4.0.0-vs-5.0.0.html
rename to doc/news/4.0.0-vs-5.0.0.h
index 7e23c4ff03..5dd3246bc0 100644
--- a/doc/news/4.0.0-vs-5.0.0.html
+++ b/doc/news/4.0.0-vs-5.0.0.h
@@ -1,27 +1,24 @@
-
-
-
-
- Changes between Version 4.0.0 and 5.0.0
-
-
-
reinit
that are used to resize the
+ reinit
that are used to resize the
matrix. However, the sparse matrix classes had an equally named
function without arguments that basically left the size of the matrix
unchanged but set all elements of the matrix to zero. It could also be
abused to notify the matrix that the sparsity pattern on which it is
built has changed, an inherently risky procedure. The no-argument code
- reinit
functions
- that take arguments. Instead, you should now use matrix=0
to simply set all elements of the
+ reinit
function has therefore been removed to
+ avoid confusion with the reinit
functions
+ that take arguments. Instead, you should now use matrix=0
to simply set all elements of the
matrix to zero. If you want to notify a sparse matrix that its sparsity
- pattern has changed, use the reinit(SparsityPattern)
function.
+ pattern has changed, use the reinit(SparsityPattern)
function.
(WB 2004/05/10)
Removed: All the vector and block vector classes as well as
- the FullMatrix
class (the latter
- through its Table
base class) had a
- member function clear
which simply
+ the FullMatrix
class (the latter
+ through its Table
base class) had a
+ member function clear
which simply
resets all values of the vector or matrix to zero. It did not
change the size of the object, though. This was confusing,
since the standard C++ container classes implement the
- semantics that the clear
functions
+ semantics that the clear
functions
delete all entries of the containers, i.e. resize it to zero,
- and we implemented similar semantics also for the SparseMatrix
, DoFHandler
, ConstraintMatrix
and various other
+ and we implemented similar semantics also for the SparseMatrix
, DoFHandler
, ConstraintMatrix
and various other
classes.
- To avoid this confusion in the future, the clear
functions have been dropped from
+ To avoid this confusion in the future, the clear
functions have been dropped from
the interface of the vector and full matrix classes, and the
remaining instances where deal.II classes have a function of
that name really mean that the object is reset to its virginal
state. To set all
elements of a matrix or vector to zero without changing its size, the
- recommended way is to use the more obvious notation vector=0
and matrix=0
. To
+ recommended way is to use the more obvious notation vector=0
and matrix=0
. To
reset the elements of a table over arbitrary objects, use
- Table<T>::reset_values()
.
+ Table<T>::reset_values()
.
(WB 2004/05/10)
Removed: The SparseLUDecomposition::reinit
and SparseMIC::reinit
functions without
+
Removed: The SparseLUDecomposition::reinit
and SparseMIC::reinit
functions without
argument had been deprecated before, and have now been removed.
(WB 2004/05/10)
Changed: the template parameter of MGTransferPrebuilt
is now the complete vector
+
Changed: the template parameter of MGTransferPrebuilt
is now the complete vector
type, not just the value type of the vector. This allows to operate
- on Vector
as well as on Vector
as well as on BlockVector
. Unfortunately, the untested class
- MGTransferBlock
underwent some more
+ MGTransferBlock
underwent some more
changes without testing, such that it should be used with high
caution.
(GK 2004/04/01)
Changed: The FiniteElement
classes had a
- function restrict
that returns the
+
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
.
+ rename the corresponding function prolongate
to get_prolongation_matrix
.
(WB 2004/02/29)
- Fixed and changed: The SolutionTransfer
::(refine_)interpolate(const Vector &in, Vector
- &out)
functions now require the in
and out
+ Fixed and changed: The SolutionTransfer
::(refine_)interpolate(const Vector &in, Vector
+ &out)
functions now require the in
and out
vectors being already of right sizes,
i.e. in.size()=n_dofs_old
and
- out.size()=n_dofs_refined
. Furthermore, the SolutionTransfer
::(refine_)interpolate(const
+
out.size()=n_dofs_refined
. Furthermore, the SolutionTransfer
::(refine_)interpolate(const
vector<Vector> &all_in, vector<Vector>
&all_out)
now check that the number of in and output
vectors are the same, i.e.
@@ -146,7 +124,7 @@ inconvenience this causes.
- Changed: The QProjector
has functions that
+ Changed: The QProjector
has functions that
project a lower-dimensional quadrature formula onto all faces or
subfaces of a cell. In 3d, it now does this but also adds projections of
these quadrature formula onto the faces from the other side. We need
@@ -159,9 +137,7 @@ inconvenience this causes.
Moved and changed: The header file
include/numerics/dof_renumbering.h has been moved to the
directory include/dofs, where it logically
- belongs. Furthermore, the sorting parameter of the function DoFRenumbering
::component_wise
has changed its meaning. See
+ belongs. Furthermore, the sorting parameter of the function DoFRenumbering
::component_wise
has changed its meaning. See
the reference documentation for details.
(GK 2003/07/03)
@@ -174,7 +150,7 @@ inconvenience this causes.
New: After the documentation tool for deal.II has been +
New: After the documentation tool for deal.II has been changed to Doxygen, it is delivered in two tar-files. Additional to the traditional source tarball, the preprocessed documentation is available ready for reading with a web browser. @@ -202,7 +178,7 @@ inconvenience this causes. (WB 2004/04/12)
-New: deal.II is now able to interface to the +
New: deal.II is now able to interface to the METIS library to generate domain partitionings. This is enabled if a METIS installation is detected, which either happens @@ -226,7 +202,7 @@ inconvenience this causes. (RH 2004/03/08)
-New: deal.II now comes with a complete set of +
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
@@ -336,11 +312,11 @@ inconvenience this causes.
simply forwards to the new program. In order to use the new
one, simply replace the line
by
- $(PERL) $D/common/scripts/make_dependencies.pl ...
+ \$(PERL) \$D/common/scripts/make_dependencies.pl ...
i.e. call the program directly without the perl interpreter and
without the file extension for a perl program.
@@ -366,14 +342,10 @@ inconvenience this causes.
- $D/common/scripts/make_dependencies ...
+ \$D/common/scripts/make_dependencies ...
- New: There is now a new PolynomialsP
- class which is based on Polynomials::Monomial
and PolynomialSpace
. In contrast to the
- default ordering of the polynomials in PolynomialSpace
, (e.g. for degree=2) 1,
- x, x2, y, xy, y2, the PolynomialsP
class now gives the
+ New: There is now a new PolynomialsP
+ class which is based on Polynomials::Monomial
and PolynomialSpace
. In contrast to the
+ default ordering of the polynomials in PolynomialSpace
, (e.g. for degree=2) 1,
+ x, x2, y, xy, y2, the PolynomialsP
class now gives the
(natural?!) ordering 1, x, y, xy, x2,
y2.
@@ -381,43 +353,40 @@ inconvenience this causes.
- New: The classes PolynomialSpace
and
- TensorProductPolynomials
now have
- new set_numbering
functions which
+ New: The classes PolynomialSpace
and
+ TensorProductPolynomials
now have
+ new set_numbering
functions which
allow to change the ordering of the polynomials. The ordering
and the indices of the polynomials kann be checked by using the
- new output_indices
functions.
+ new output_indices
functions.
(RH 2004/03/11)
New: The class PolynomialsBDM
implements BDM polynomials in
+
New: The class PolynomialsBDM
implements BDM polynomials in
two dimensions on the unit square. It was implemented as is
according to some urgent need, but should be suitable to be fit
- into a FiniteElement
similar to
+ into a FiniteElement
similar to
Raviart/Thomas.
(GK 2004/01/05)
New: Objects of type Polynomial
+
New: Objects of type Polynomial
can now be added to and subtracted from each other through
- operators +=
and -=
.
+ operators +=
and -=
.
(GK 2003/12/16)
New: There is now a class QuadratureSelector
that allows to select a
+
New: There is now a class QuadratureSelector
that allows to select a
quadrature formula based on a string argument and possibly a
number indicating the order of the formula.
(Ralf B. Schulz 2003/10/29)
Fixed: The constructor of the QGauss
class
+
Fixed: The constructor of the QGauss
class
computed positions and weights of quadrature points in long double accuracy.
However, on machines where long double is the same as double, it
never reached the requested accuracy, in effect leading to an infinite loop.
@@ -426,15 +395,14 @@ inconvenience this causes.
(WB 2003/09/19)
New: The Function
class now
+
New: The Function
class now
exports the value of its template argument through the static
- member variable dimension
.
+ member variable dimension
.
(WB 2003/09/15)
Changed: The ParameterHandler::declare_entry
function
+
Changed: The ParameterHandler::declare_entry
function
now allows to redeclare an entry that has already been
declared. This can be used to override a default value
previously set.
@@ -442,20 +410,17 @@ inconvenience this causes.
(WB 2003/09/03)
Improved: The ParameterHandler::declare_entry
function now takes an
+
Improved: The ParameterHandler::declare_entry
function now takes an
additional parameter (defaulting to the empty string) that can be used
to document the intent of a parameter. This string, together with the
- default value of an entry, is written to the output by the ParameterHandler::print_parameters
function that
+ default value of an entry, is written to the output by the ParameterHandler::print_parameters
function that
can be used to generate a virginial parameter file, or one that contains
the settings of all parameters used in a computation.
(WB 2003/08/13)
Changed: The ParameterHandler::declare_entry
previously
+
Changed: The ParameterHandler::declare_entry
previously
returned a value indicating whether the just-declared entry didn't
already existed and that the default value matches the given
pattern. However, this value could only always be true since these two
@@ -466,13 +431,7 @@ inconvenience this causes.
(WB 2003/08/13)
Improved: Logstream
::depth_console
, Logstream
::depth_file
, Logstream
::log_execution_time
and Logstream
::log_time_differences
return the previous value.
+
Improved: Logstream
::depth_console
, Logstream
::depth_file
, Logstream
::log_execution_time
and Logstream
::log_time_differences
return the previous value.
(GK 2003/06/22)
Improved: The matrix-vector operations of SparseMatrix
accept arguments of type BlockVector
.
+
Improved: The matrix-vector operations of SparseMatrix
accept arguments of type BlockVector
.
(GK/2004/03/31)
Fixed: The SparseMatrix
iterator classes
+
Fixed: The SparseMatrix
iterator classes
had various interesting bugs when rows of the matrix were completely
empty. These should now be fixed.
(WB 2004/03/30)
New: The SparsityPattern
class now also
+
New: The SparsityPattern
class now also
has an iterator class that allows to walk over all nonzero entries of a
sparsity pattern.
(WB 2004/03/29)
New: The iterator classes into SparseMatrix
have been rearranged and extended, so
+
New: The iterator classes into SparseMatrix
have been rearranged and extended, so
that it is now also possible to write to individual matrix entries
through these iterators.
(WB 2004/03/29)
New: The Vector
and BlockVector
classes now have member functions
- is_non_negative
that check whether a vector
+
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)
Fixed: The SolverMinRes
class had a nasty bug where we were
+
Fixed: The SolverMinRes
class had a nasty bug where we were
inadvertently copying vectors; this could also have led to a memory
corruption bug. This is now fixed.
(WB 2004/02/26)
New: There is now a function FullMatrix::add_scaled
. It replaces the old
- function FullMatrix::add
which did the same,
+
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)
New: FullMatrix
has new functions add
and ,Tadd
+
New: FullMatrix
has new functions add
and ,Tadd
allowing to add to a selected block of the matrix.
(GK 2004/02/12)
New: The Vector
class now has operators to compare for
+
New: The Vector
class now has operators to compare for
equality and inequality.
(WB 2004/02/09)
New: The SparseMatrix::operator()
generated an assertion
+
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.
@@ -562,37 +511,33 @@ inconvenience this causes.
(WB 2004/02/06)
New: There is now a function SparseMatrix::frobenius_norm
that computes the
+
New: There is now a function SparseMatrix::frobenius_norm
that computes the
Frobenius norm of a sparse matrix.
(WB 2004/02/06)
Changed: In matrix-vector operations of the Full/SparseMatrix
classes, source and destination
+
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)
Improved: Initialization routines of class SparseMatrix
have an additional parameter
+
Improved: Initialization routines of class SparseMatrix
have an additional parameter
controlling the storage of diagonal entries.
(GK 2003/11/18)
New:
- SolverFGMRES
implements the flexible
+ SolverFGMRES
implements the flexible
GMRES method with varying preconditioner from the right. It is
- also accessible in SolverSelector
by choosing fgmres.
+ also accessible in SolverSelector
by choosing fgmres.
(GK 2003/10/07)
Changed: The SparseDirectMA27
+
Changed: The SparseDirectMA27
class used to store a pointer to the sparsity pattern of the
matrix. It now releases this as soon as it doesn't need it any
more.
@@ -601,25 +546,22 @@ inconvenience this causes.
New: Some of the member matrix-vector functions of the
- BlockSparseMatrix
class that
- previously could only be used with arguments of type BlockVector
can now also be used with the
- usual Vector
class provided the
+ BlockSparseMatrix
class that
+ previously could only be used with arguments of type BlockVector
can now also be used with the
+ usual Vector
class provided the
block matrix has only one block row or column.
(WB 2003/09/09)
Fixed: FullMatrix
::copy_from
didn't compile when copying
+
Fixed: FullMatrix
::copy_from
didn't compile when copying
from a sparse matrix. This is now fixed.
(Ralf B. Schulz 2003/09/04)
New: The classes FullMatrix
and
- PreconditionBlockJacobi
have a const_iterator
.
+
New: The classes FullMatrix
and
+ PreconditionBlockJacobi
have a const_iterator
.
(GK 2003/07/18)
Improved: The DoFTools::compute_Cuthill_McKee
function
+
Improved: The DoFTools::compute_Cuthill_McKee
function
needs to build a sparsity pattern for its operations, and uses
- the DoFHandler::max_couplings_per_dof
+ the DoFHandler::max_couplings_per_dof
function for this. However, the estimates returned by the
latter function are rather bad in 3d, leading to excessive
memory allocation in the Cuthill McKee algorithm in 3d. This is
@@ -645,33 +585,29 @@ inconvenience this causes.
(WB 2004/05/18)
Improved: Triangulation
has
- functions n_faces
and n_active_faces
, globally as well as by level,
- similar to n_cells
.
+
Improved: Triangulation
has
+ functions n_faces
and n_active_faces
, globally as well as by level,
+ similar to n_cells
.
(GK 2004/05/18)
New: Added support for gmsh mesh format in GridIn::read_msh
.
+ target="_top">gmsh mesh format in GridIn::read_msh
.
(Luca Heltai 2004/04/21)
- New: The function GridGenerator::cylinder_shell
generates a domain
+ New: The function GridGenerator::cylinder_shell
generates a domain
of the type which the name suggests.
(WB 2004/04/19)
- Changed: The KellyErrorEstimator::estimate
function takes an
+ Changed: The KellyErrorEstimator::estimate
function takes an
additional parameter that lets it only compute error indicators for a
certain subdomain. This is meant to allow for a better parallelization
of efforts in parallel programs.
@@ -680,66 +616,52 @@ inconvenience this causes.
- Changed: MGTransferSelect
uses target components
- correctly. Unfortunately, the untested class MGTransferBlock
does not work anymore. Since its
+ Changed: MGTransferSelect
uses target components
+ correctly. Unfortunately, the untested class MGTransferBlock
does not work anymore. Since its
usefulness was not clear anyway, this state may continue for a while.
(GK 2004/04/01)
- New: There is now a new FE_Poly
- class which is templatized for polynomial spaces like TensorProductPolynomials
, PolynomialSpace
or PolynomialsP
. Many finite element classes
+ New: There is now a new FE_Poly
+ class which is templatized for polynomial spaces like TensorProductPolynomials
, PolynomialSpace
or PolynomialsP
. Many finite element classes
are now derived from this class and the implementation of all
common functionality is now moved from these finite element
- classes to FE_Poly
.
+ classes to FE_Poly
.
(RH 2004/03/18)
New: The new function MatrixTools::local_apply_boundary_values
folds
+
New: The new function MatrixTools::local_apply_boundary_values
folds
boundary value information into local matrices and vectors before they
are written into the global matrix and vector. This way, the final call
- to MatrixTools::apply_boundary_values
can
+ to MatrixTools::apply_boundary_values
can
be avoided.
(WB 2004/03/16)
New: There are now functions ConstraintMatrix::distribute_local_to_global
that
+
New: There are now functions ConstraintMatrix::distribute_local_to_global
that
take a local matrix or vector and distribute it to a global one, but
taking care of constrained degrees of freedom; in that case, the
respective entries are already distributed to the final place in the
- global matrix or vector. That way, the final call to the ConstraintMatrix::condense
function can be
+ global matrix or vector. That way, the final call to the ConstraintMatrix::condense
function can be
avoided.
(WB 2004/03/15)
New: The new functions SparsityPattern::partition
, GridTools::partition_triangulation
, DoFTools::get_subdomain_association
, DoFTools::count_dofs_with_subdomain_association
,
- GridTools::get_subdomain_association
, GridTools::count_cells_with_subdomain_association
,
- and DoFRenumbering::subdomain_wise
can now
+
New: The new functions SparsityPattern::partition
, GridTools::partition_triangulation
, DoFTools::get_subdomain_association
, DoFTools::count_dofs_with_subdomain_association
,
+ GridTools::get_subdomain_association
, GridTools::count_cells_with_subdomain_association
,
+ and DoFRenumbering::subdomain_wise
can now
be used to generate partitions of a triangulation and its associated
degrees of freedom suitable for parallel computations with PETSc.
(WB 2004/03/08)
Improved: When eliminating nodes from a matrix using the ConstraintMatrix::condense
functions, the
+
Improved: When eliminating nodes from a matrix using the ConstraintMatrix::condense
functions, the
diagonal entry was set to one. It is now set to an entry that more
resembles the size of the other diagonal entries, so that we don't run
into scaling problems for applications that have very large or small
@@ -748,8 +670,7 @@ inconvenience this causes.
(WB 2004/03/02)
Changed: The classes DataOut*
and KellyErrorEstimator
have been generalized to take
+
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
@@ -758,10 +679,8 @@ inconvenience this causes.
(WB 2004/03/01)
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
+
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
@@ -773,26 +692,13 @@ inconvenience this causes.
New: The function
- FETools::project_dg
performs L2-projections between finite element spaces
of different degrees on the same mesh.
(GK 2003/11/28)
- Improved: FiniteElementData
has a function
-
- (GK 2003/11/28)
-
- New: Long requested but never implemented before in the
- library: there is now a function GridTool
::FiniteElementData
has a function>tensor_degree(), returning the degree of thesuitable for choosing a tensor product quadratureimplemented before in theis now a function GridTool
::find_active_cell_around_point
that, given a point, finds the active cell in which this point
lies.
@@ -800,37 +706,31 @@ inconvenience this causes.
- New: MGCoarseGridHouseholder
+ New: MGCoarseGridHouseholder
implements a coarse grid solver using QR-factorization.
(GK 2003/10/17)
- Fixed: The FEFaceValuesBase::boundary_form
+ Fixed: The FEFaceValuesBase::boundary_form
function was declared but not implemented. This is now fixed.
(Jörg R. Weimar 2003/10/22)
- Improved: The MatrixCreator::create_mass_matrix
+ Improved: The MatrixCreator::create_mass_matrix
functions are now templatized also on the template argument of
- the SparseMatrix
class. This allows
- invoking this function for SparseMatrix<double>
and SparseMatrix<float>
objects.
+ the SparseMatrix
class. This allows
+ invoking this function for SparseMatrix<double>
and SparseMatrix<float>
objects.
(RH 2003/10/22)
- New: There is now also a function MGDoFCellAccessor::neighbor_child_on_subface
- that returns the result of the CellAccessor::neighbor_child_on_subface
+ New: There is now also a function MGDoFCellAccessor::neighbor_child_on_subface
+ that returns the result of the CellAccessor::neighbor_child_on_subface
function but converts it so that one can also access MGDoF
data.
@@ -838,18 +738,15 @@ inconvenience this causes.
- New: There are now functions CellAccessor::neighbor_child_on_subface
and DoFCellAccessor::neighbor_child_on_subface
- that should be called instead of using GeometryInfo::child_cell_on_face
in most cases.
+ New: There are now functions CellAccessor::neighbor_child_on_subface
and DoFCellAccessor::neighbor_child_on_subface
+ that should be called instead of using GeometryInfo::child_cell_on_face
in most cases.
(WB 2003/10/17)
- New: GridGenerator
has a new
- function subdivided_hyper_rectangle
+ New: GridGenerator
has a new
+ function subdivided_hyper_rectangle
which generates a rectangle with given corner points and possibly
different numbers of subdivisions in different directions.
Use it, e.g., to generate a domain of 1*4 length units
@@ -859,8 +756,7 @@ inconvenience this causes.
- Improved: The 3d grid reordering code in the GridReordering
class now uses an algorithm
+ Improved: The 3d grid reordering code in the GridReordering
class now uses an algorithm
that is linear in the number of elements. The old code was
exponential, so this is a vast improvement.
@@ -868,54 +764,48 @@ inconvenience this causes.
- Improved: GridOut
has a an improved
- functionality for write_eps
+ Improved: GridOut
has a an improved
+ functionality for write_eps
to color the grid according to the refinement level.
A corresponding option is included in
- GridOutFlags::Eps<2>
.
+ GridOutFlags::Eps<2>
.
(Joerg Weimar 2003/09/09)
New: The TriaAccessor
::point_inside
function is now also
+
New: The TriaAccessor
::point_inside
function is now also
implemented in 3d.
(Joerg Weimar, WB 2003/09/04)
New: The TriaAccessor
::recursively_set_material_id
function sets
+
New: The TriaAccessor
::recursively_set_material_id
function sets
the material id of the present cell and of all its children,
grandchildren, etc to the given value.
(WB 2003/09/04)
New: The new FETools
::get_fe_from_name
function can do the
- reverse of the FiniteElement
::get_name
function: it takes a string and
+
New: The new FETools
::get_fe_from_name
function can do the
+ reverse of the FiniteElement
::get_name
function: it takes a string and
parses it to regenerate a finite element from it. Useful for
parsing finite element names from input files.
(WB 2003/07/08)
New: The DataOut_DoFData
::merge_patches
now takes a second
+
New: The DataOut_DoFData
::merge_patches
now takes a second
parameter that indicates a shift for each vertex of the given
patches to be merged. This is sometimes nice if one wants to
generate "exploded" views of a collection of subdomains. It is
also templatized on the first argument, so can merge in some
- other DataOut_DoFData
that create
+ other DataOut_DoFData
that create
the same type of patches but are otherwise different.
(WB 2003/06/30)
Fixed: The FETools
::extrapolate
function operates on patches
+
Fixed: The FETools
::extrapolate
function operates on patches
of cells, but didn't check whether the grid is at least refined
once everywhere. If this was not the case, it would generate
wrong results. It now checks for this, and if the grid has
@@ -925,8 +815,8 @@ inconvenience this causes.
- Improved: FEFaceValuesBase
has a new
- function orientation
accessing a unique
+ Improved: FEFaceValuesBase
has a new
+ function orientation
accessing a unique
and consistent orientation for each face.
(GK 2003/06/23)
@@ -943,12 +833,10 @@ inconvenience this causes.
- New: Finite elements got a function get_interpolation_matrix
, with which they can
+ New: Finite elements got a function get_interpolation_matrix
, with which they can
compute interpolations between different finite elements. Most will use
this to compute interpolations between finite elements of the same kind
- but different polynomial degrees. The FETools::get_interpolation_matrix
makes use of
+ but different polynomial degrees. The FETools::get_interpolation_matrix
makes use of
this function if it implements the desired interpolation, and falls back
to the old algorithm if this is not the case.
@@ -956,23 +844,18 @@ inconvenience this causes.
- New: Finite elements got a function get_name
, which can be used to identify a finite
+ New: Finite elements got a function get_name
, which can be used to identify a finite
element by its name.
(WB 2003/06/09)
- New: Raviart-Thomas elements are now implemented in the FE_RaviartThomas
class.
+ New: Raviart-Thomas elements are now implemented in the FE_RaviartThomas
class.
(WB 2003/06/09)
-This is the list of changes made after the release of -deal.II version 5.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. -
+// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2013, 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + +/** + * @page changes_between_5_0_and_5_1 Changes between Version 5.0 and 5.1+This is the list of changes made between the deal.II releases listed above. 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). @@ -46,7 +43,7 @@ inconvenience this causes.
Changed: The call MGTransferBlock
::build_matrices
and to the same function in
- derived classes receaves a DoFHandler
as
+ derived classes receaves a DoFHandler
as
an additional argument. It is needed to prebuild the transfer
between vectors and multigrid vectors, since the loop over all cells
is to slow.
@@ -113,7 +110,7 @@ inconvenience this causes.
Improved: The documentation generated by Doxygen now states the header
- file defining a class. Furthermore, all deal.II
+ file defining a class. Furthermore, all deal.II
exceptions are listed as classes and will soon be found in the module
Exceptions.
@@ -159,15 +156,15 @@ inconvenience this causes.
- New: The
+ New: The
TableHandler::write_tex
now accepts the additional boolean
- argument with_header
which is set to
+ argument with_header
which is set to
true by default and tells the function whether to add the latex
- header and footer (i.e. the \documentclass{...},
- \begin{document} and \end{document} stuff) to the table.
+ header and footer (i.e. the \\documentclass{...},
+ \\begin{document} and \\end{document} stuff) to the table.
In addition to this, there are two new members in the above class:
- TableHandler::tex_set_table_caption
and
- TableHandler::tex_set_table_label
to
+ TableHandler::tex_set_table_caption
and
+ TableHandler::tex_set_table_label
to
add a caption and a label to the tex generated table.
(Luca Heltai 2004/10/29)
@@ -183,7 +180,7 @@ inconvenience this causes.
- New: a class template VectorSlice
+ New: a class template VectorSlice
allows access to consecutive portions of a vector.
(GK 2004/09/16)
@@ -202,14 +199,14 @@ inconvenience this causes.
- New: Class TableIndices
now has
+ New: Class TableIndices
now has
operators that check for equality and inequality of objects.
(WB 2004/07/28)
- New: A class PointerComparison
for comparing
+ New: A class PointerComparison
for comparing
pointers that may or may not be of the same type.
(WB 2004/06/22)
@@ -255,13 +252,13 @@ inconvenience this causes.
- New: A class PreconditionLU
which
+ New: A class PreconditionLU
which
provides a wrapper to the complete LU decomposition
preconditioner of PETSc. Furthermore a class
- SolverPreOnly
was implemented. It
+ SolverPreOnly
was implemented. It
is a wrapper for the PETSc solver type KSPPREONLY, which
only applies the preconditioner. In conjunction with
- PreconditionLU
this provides a
+ PreconditionLU
this provides a
simple direct solver, which could be used for small to medium
sized problems on a single processor machine.
@@ -269,11 +266,11 @@ inconvenience this causes.
- Improved: VectorTools::point_difference
+ Improved: VectorTools::point_difference
used to use an algorithm to find the cell the given point is in that
was linear in the total number of active cells. It has been rewritten
to use
- GridTools::find_active_cell_around_point
+ GridTools::find_active_cell_around_point
which is only logarithmic in its complexity.
(WB 2004/07/07)
@@ -290,10 +287,10 @@ inconvenience this causes.
Removed: Block matrix iterators used to have a function
- it->index()
that returned something like
+ it->index()
that returned something like
the position within a row. However, this was fragile, and has been
removed. If you want an ordering of elements within a row, use the
- operator <
to compare iterators.
+ operator <
to compare iterators.
(WB 2004/07/07)
- Improved: The SparseDirectMA27
class can now
+ Improved: The SparseDirectMA27
class can now
handle float as well as double input matrices and vectors.
(WB 2004/06/23)
@@ -327,7 +324,7 @@ inconvenience this causes.
- Improved: The CompressedSparsityPattern
+ Improved: The CompressedSparsityPattern
class used one of the C++ standard containers to store the column
indices of nonzero entries in a sparse matrix. This proved to be
inefficient since it requires the allocation of 20 bytes each time an
@@ -351,7 +348,7 @@ inconvenience this causes.
- Fixed: BlockSparseMatrix::clear()
did not
+ Fixed: BlockSparseMatrix::clear()
did not
do what it was supposed to do: it emptied the individual blocks and
removed them, but it still kept the number of blocks
unchanged. Subsequent accesses to these blocks, or to their information
@@ -388,8 +385,8 @@ inconvenience this causes.
New: In analogy to the PETSc vector classes, the PETSc matrix classes
- now also have member functions local_range
,
- in_local_range
, and local_range
,
+ in_local_range
, and local_size
.
(WB 2004/06/02)
@@ -397,7 +394,7 @@ inconvenience this causes.
New: Parallel PETSc matrix and vector classes now have member functions
- get_mpi_communicator
that returns the MPI
+ get_mpi_communicator
that returns the MPI
communicator object these objects operate on.
(WB 2004/06/02)
@@ -407,7 +404,7 @@ inconvenience this causes.
Changed: The PETSc linear solver classes now take a constant, rather
than a nonconstant reference to the MPI communicator to be used. This
prevents some unnecessary compiler problems in conjunction with the new
- get_mpi_communicator
function.
+ get_mpi_communicator
function.
(WB 2004/06/02)
- Improved: GeometryInfo
has two new
- fields unit_normal_direction
and
- unit_normal_orientation
,
+ Improved: GeometryInfo
has two new
+ fields unit_normal_direction
and
+ unit_normal_orientation
,
indicating the direction of the unit normal vector for each
face of the reference cell.
@@ -450,7 +447,7 @@ inconvenience this causes.
(WB 2004/11/12)
Fixed: The Fixed: The
- Improved: Now the
- Improved: The
- Fixed: The
- New: The
- New: The
- New: The new GridGenerator
::
GridGenerator
::cylinder
function in 3d assigned the
wrong boundary value to the top and bottom part of the cylinder
if the half length of the cylinder was not equal to 1. This is
@@ -460,7 +457,7 @@ inconvenience this causes.
FE_Q
class supports hanging node
+ Improved: Now the FE_Q
class supports hanging node
constraints for elements of arbitrary polynomial degree also in
3D.
@@ -477,7 +474,7 @@ inconvenience this causes.
CylinderBoundary
+ Improved: The CylinderBoundary
represented the hull of a circular tubes along the x-axis. It
is now extended to allow for circular tubes also along the y-
and z-axis.
@@ -486,7 +483,7 @@ inconvenience this causes.
ConstraintMatrix
class had some
+ Fixed: The ConstraintMatrix
class had some
algorithms that were linear in the number of constraints. Since these
functions had to be called for each constraint, this resulted in a
quadratic behavior. To make things worse, these algorithms traversed
@@ -499,7 +496,7 @@ inconvenience this causes.
GridOut
::GridOut
::write_gnuplot
function now supports
curved boundaries also for dim==3
.
@@ -510,7 +507,7 @@ inconvenience this causes.
Fixed: The documentation of the Triangulation
class mentioned that no
places in the library use or touch the user pointers. That is
- wrong, the SolutionTransfer
class
+ wrong, the SolutionTransfer
class
actually does. This is now properly documented.
(WB 2004/09/15)
@@ -526,7 +523,7 @@ inconvenience this causes.
MatrixTools::apply_boundary_values
+ New: The MatrixTools::apply_boundary_values
that works on block matrices and vectors is now templatized over the
number type, i.e. it also works for float matrices and vectors.
@@ -534,9 +531,9 @@ inconvenience this causes.
FEValuesBase::get_cell
+ New: The new FEValuesBase::get_cell
function returns the current cell, i.e. the latest cell the
- FEValues
object was reinited with.
+ FEValues
object was reinited with.
(RH 2004/06/22)
MatrixTools
class.
+ documentation of the MatrixTools
class.
(WB 2004/06/07)
- Fixed: The GridGenerator::cylinder_shell
+ Fixed: The GridGenerator::cylinder_shell
function generated cells were all inside-out, i.e. had negative
Jacobians. In usual finite element computations this simply leads to
all components of the linear system being negated, so it is not
@@ -567,8 +564,6 @@ inconvenience this causes.
-This is the list of changes made after the release of -deal.II version 5.1. 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. -
+// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2013, 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + +/** + * @page changes_between_5_1_and_5_2 Changes between Version 5.1 and 5.2
+This is the list of changes made between the deal.II releases listed above.
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).
@@ -72,7 +67,7 @@ inconvenience this causes.
Changed: The class MGCoarseGridLACIteration
lost two template
arguments. Since the matrix and preconditioner are now stored
- in form of PointerMatrix
objects,
+ in form of PointerMatrix
objects,
handling of the class is much simpler, in particular when
exchanging preconditioners.
@@ -87,16 +82,16 @@ inconvenience this causes.
requires an additional argument of type VectorMemory<Vector<number> >
providing space for auxiliary vectors. Since the entries are
- now of type PointerMatrixBase
, even
+ now of type PointerMatrixBase
, even
matrices with blocks of different types can be constructed.
(GK 2005/03/21)
- Changed: The
- Changed:
- Changed:
- New: Class
- New: A function
- Improved: The
Changed: Some of the dimension independent functions in the
- Improved: The class
- New: The
- New: The
- New: The
- New: The
- New: The
- New: There is a new class
- New: Class
- New: Class
- Fixed:
- Improved:
- Fixed: The
- New: The
- New: The Fixed: The Fixed: The Fixed: The Fixed: The New: The New: The Fixed: The Fixed: The Removed: The class New: class New: class
Remove: Due to the reimplementation of the 3d reordering
- algorithm in
Fixed: It was possible to compare iterators into different
-
- New: The
- New: The
- New: Function
- Improved: All
- Improved: The
- Changed: The method
- New: The method
- New: The
- New: The
- New: The
- Improved: The
- New: The
- Improved: The function
- Fixed: The
- New: The new
- New: The new
- New: The new
- Changed: The
- Fixed: The class
- Fixed: The class
- New: Function
-This is the list of changes made after the release of
-deal.II version 5.2. 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.
-
+This is the list of changes made between the deal.II releases listed above.
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).
GeometryInfo
::GeometryInfo
::vertices_adjacent_to_line
function has
- been renamed to GeometryInfo
::GeometryInfo
::line_to_cell_vertices
to be named
analogous to the face_to_cell_vertices
,
DoFTools
::DoFTools
::make_flux_sparsity_pattern
, MGTools
::make_flux_sparsity_pattern
and similar
functions in these classes do not receive arguments of type
- FullMatrix<double>
+ FullMatrix<double>
anymore. Instead, they get a Table<2,DoFTools::Coupling>
, which
contains more meaningful enums.
@@ -129,12 +124,12 @@ inconvenience this causes.
Multigrid
::Multigrid
::Multigrid
receives an argument
determining the type of multigrid cycle instead of the minimum
and maximum levels. The latter were rarely used anyway and can
- be modified by set_minlevel()
and
- set_maxlevel()
+ be modified by set_minlevel()
and
+ set_maxlevel()
(GK 2005/03/09)
-PathSearch
allows to find
+ New: Class PathSearch
allows to find
a file in a sequence of directories and by appending suffixes. The class
generates the complete file name including directory prefix and suffix
such that it can be used for subsequently opening the file.
@@ -322,7 +317,7 @@ inconvenience this causes.
+ New: A function
deal_II_exceptions::disable_abort_on_exception
now allows
to disable program abortion when an assertion fails. This is used
in regression tests.
@@ -331,8 +326,8 @@ inconvenience this causes.
QProjector
now has
- functions project_to_face
and QProjector
now has
+ functions project_to_face
and project_to_subface
returning a Quadrature
object
@@ -360,7 +355,7 @@ inconvenience this causes.
DataOutInterface
class have been moved into the
- DataOutBase
class that does not depend on any
+ DataOutBase
class that does not depend on any
dimension template parameters. Since the latter is a base class of the
former, there should be no problems for application programs.
@@ -402,7 +397,7 @@ inconvenience this causes.
Quadrature
has a new
+ Improved: The class Quadrature
has a new
constructor generating the dim-dimensional tensor product of a
one-dimensonal formula directly.
@@ -418,7 +413,7 @@ inconvenience this causes.
Polynomials::Lagrange
class
+ New: The Polynomials::Lagrange
class
allows generation of Lagrange interpolation polynomials for
arbitrary point sets. In order to get better interpolation for
higher order polynomials,
QAnisotropic
class allows
+ New: The QAnisotropic
class allows
generation of quadrature rules of different order in each
space dimension.
@@ -438,7 +433,7 @@ inconvenience this causes.
Tensor
classes now
+ New: The Tensor
classes now
have member functions that compute the Frobenius norm and its
square. There are also global operator*
functions
that compute the contraction over a pair of indices of tensors.
@@ -447,7 +442,7 @@ inconvenience this causes.
DataOutBase
class now
+ New: The DataOutBase
class now
allows to write data in a new intermediate format that
basically dumps the raw information available in patches.
@@ -455,7 +450,7 @@ inconvenience this causes.
DataOutReader
class allows
+ New: The DataOutReader
class allows
to read data back in from a file into which it has been written
using intermediate format. From there, it can then be converted
into any of the supported graphics formats.
@@ -491,14 +486,14 @@ inconvenience this causes.
SymmetricTensor
+ New: There is a new class SymmetricTensor
that provides storage and operations for symmetric tensors.
(WB, 2005/03/28)
Subscriptor
receives a
+ New: Class Subscriptor
receives a
text argument allowing to identify the violating pointer more
easily. The additional feature is being incorporated into SmartPointer
constructors throughout the
@@ -508,7 +503,7 @@ inconvenience this causes.
FunctionParser
. Wrapper
+ New: Class FunctionParser
. Wrapper
class for the fparser library (see
http://warp.povusers.org/FunctionParser/).
@@ -522,7 +517,7 @@ inconvenience this causes.
virtual abstract functions but no virtual destructor. This caused
warnings with some compilers, and is generally bad practice
anyway. This is now fixed. The same holds with respect to the class
- DataOutInterface
.
+ DataOutInterface
.
(WB, 2005/02/20)
SparsityPattern
::SparsityPattern
::block_write
neither wrote the number of
columns of the pattern, nor the flag for optimizing the
- diagonal, and SparsityPattern
::SparsityPattern
::block_read
did not attempt to read this
data. Both is fixed now.
@@ -564,7 +559,7 @@ inconvenience this causes.
SparseDirectUMFPACK
now
+ Improved: SparseDirectUMFPACK
now
has the complete interface of a preconditioner
class. Therefore, it can be used in iterative solvers and in
multigrid smoothers.
@@ -580,7 +575,7 @@ inconvenience this causes.
PETScWrappers::MPI::SparseMatrix
+ Fixed: The PETScWrappers::MPI::SparseMatrix
class had functions that allow to take a pre-existing sparsity pattern
as the basis for entry allocation. These functions had an option to
allow pre-setting these entries in the underlying data structures, but
@@ -593,21 +588,21 @@ inconvenience this causes.
ProductSparseMatrix
+ New: The ProductSparseMatrix
implements the product of two rectangular sparse matrices with
- the same value_type
+ the same value_type
(GK, 2005/03/11)
PreconditionRichardson
+ New: The PreconditionRichardson
implements a Richardson preconditioner.
(GK, 2005/03/10)
BlockSparseMatrix
+ BlockSparseMatrix
class had no local typedef value_type
like all other classes, which
made it a little awkward to use in some places. This has now
@@ -617,7 +612,7 @@ inconvenience this causes.
(WB, 2005/03/03)
PETScWrappers
::
PETScWrappers
::MatrixBase
class documented that adding
or setting a value that hasn't been in the sparsity pattern
before will lead to an exception being thrown. This is of
@@ -626,15 +621,15 @@ inconvenience this causes.
(WB, 2005/03/03)
SparseMatrix
iterators
- had no operator >
, only an
SparseMatrix
iterators
+ had no operator >
, only an operator <
. The missing operator is
now implemented. The same holds for the FullMatrix
class.
(WB, 2005/03/01)
SparseMatrix
+ SparseMatrix
iterators could not be compared using operator <
: the compiler complained
that a private member was accessed. This is now fixed.
@@ -651,13 +646,13 @@ inconvenience this causes.
FiniteElementBase
has been removed and all its
- functions are now in FiniteElement
.
+ functions are now in FiniteElement
.
(GK, 2005/08/25)
DoFTools
now has two
- functions compute_row_length_vector
, one
+ DoFTools
now has two
+ functions compute_row_length_vector
, one
for equations and one for systems. These give a much finer estimate
for the size of the sparsity pattern required than DoFHandler
::
GridReordering
two
- years ago, the CellData::rotate
+ algorithm in GridReordering
two
+ years ago, the CellData::rotate
function got obsolete. CellData::rotate
is now removed.
@@ -679,7 +674,7 @@ inconvenience this causes.
DoFHandler
objects for equality and
+ DoFHandler
objects for equality and
inequality as long as the underlying triangulation object was
the same. This doesn't make much sense, however, and even
sometimes declared to iterators equal if only they had the same
@@ -690,7 +685,7 @@ inconvenience this causes.
DataOutStack::add_data_vector
+ New: The DataOutStack::add_data_vector
function now also allows to give only a single name even if the data is
vector-valued. It then makes up names for the individual components by
adding numbers to the name, just like the
DataOutStack
class can now also be
+ New: The DataOutStack
class can now also be
used to stack two-dimensional time or parameter dependent data into a 3d
output.
@@ -708,7 +703,7 @@ inconvenience this causes.
FETools
::FETools
::compute_face_embedding_matrices
allows for
automatic computation of embedding matrices on faces under the sole
assumption that the coarse grid space is embedded into the fine
@@ -722,12 +717,12 @@ inconvenience this causes.
GridIn
::GridIn
::read_*
functions now call GridReordering
::invert_all_cells_of_negative_grid
. This
way, also misoriented grids are represented in the right
- orientation within deal.II.
+ orientation within deal.II.
(RH 2005/07/06)
DoFTools
::count_dofs_per_component
and its
- counterpart in MGTools
got an
+ counterpart in MGTools
got an
additional argument. This argument allows to count the degrees
of freedom of nonprimitive vector valued elements only once,
instead of in every component. Although this argument defaults
@@ -810,7 +805,7 @@ inconvenience this causes.
GeometryInfo
::GeometryInfo
::child_cell_on_face
, face_to_cell_vertices
and face_to_cell_lines
now have an additional
@@ -825,24 +820,24 @@ inconvenience this causes.
FETools
::FETools
::lexicographic_to_hierarchic_numbering
now
- takes a FiniteElementData
instead of
- a FE_Q
object. Now this function can
- also be called by the FE_Q
+ takes a FiniteElementData
instead of
+ a FE_Q
object. Now this function can
+ also be called by the FE_Q
constructor which avoids code duplication.
(RH, 2005/06/13)
create_mass_matrix
- in class MatrixCreator
can now handle
+ New: The method create_mass_matrix
+ in class MatrixCreator
can now handle
vector valued finite elements. A similar change was applied
- to create_right_hand_side
and
- create_boundary_right_hand_side
- in VectorTools
. These two changes
- now make the project
function work also
+ to create_right_hand_side
and
+ create_boundary_right_hand_side
+ in VectorTools
. These two changes
+ now make the project
function work also
for Raviart-Thomas elements and other vector valued FEs. This
is very useful, if some initial conditions have to be specified.
@@ -850,18 +845,18 @@ inconvenience this causes.
DataOut
class
+ New: The DataOut
class
now supports Eulerian Mappings. If a solution is computed
on a deformed mesh, the output file generated by the DataOut
now shows the solution also on the deformed mesh. This
is an option and requires the mapping to be specified as
- additional parameter to build_patches
.
+ additional parameter to build_patches
.
(Oliver Kayser-Herold, 2005/05/31)
MappingQ1Eulerian
class can
+ New: The MappingQ1Eulerian
class can
now cope with different vector types for the Euler vector.
This is useful if it should be used with the PETSc wrapper
classes. The desired vector type can be specified as template
@@ -871,7 +866,7 @@ inconvenience this causes.
FE_RaviartThomasNodal
+ New: The FE_RaviartThomasNodal
implements Raviart-Thomas elements using function values in
Gauss quadrature points on edges and in the interior for its
node values. The implementation is restricted to Cartesian mesh
@@ -881,22 +876,22 @@ inconvenience this causes.
Mapping::transform_*
- functions accept VectorSlice
instead
- of Vector
, thus allowing more flexibility.
+ Improved: The Mapping::transform_*
+ functions accept VectorSlice
instead
+ of Vector
, thus allowing more flexibility.
(GK, 2005/05/24)
MatrixTools::apply_boundary_values
+ New: The MatrixTools::apply_boundary_values
function now also works for PETSc sequential and parallel matrices.
(WB, 2005/05/05)
GridIn
::GridIn
::read
now searches for files using the
mechanism provided by the class PathSearch
. Furthermore, a library of input
@@ -906,9 +901,9 @@ inconvenience this causes.
DataOut
class did not work
- properly if the DataOut::first_cell
and
- DataOut::next_cell
functions were
+ Fixed: The DataOut
class did not work
+ properly if the DataOut::first_cell
and
+ DataOut::next_cell
functions were
overloaded and cell data was to be output; in that case, data from the
wrong cells was written out. This is now fixed. In contrast to this,
nodal data was never affected.
@@ -933,7 +928,7 @@ inconvenience this causes.
GeometryInfo
::GeometryInfo
::line_to_cell_vertices
function maps line
vertex numbers to cell vertex numbers.
@@ -941,7 +936,7 @@ inconvenience this causes.
GeometryInfo
::GeometryInfo
::face_to_cell_lines
function maps face
line numbers to cell line numbers.
@@ -949,7 +944,7 @@ inconvenience this causes.
GeometryInfo
::GeometryInfo
::face_to_cell_vertices
function maps face
vertex numbers to cell vertex numbers.
@@ -966,19 +961,19 @@ inconvenience this causes.
Triangulation<2>
::Triangulation<2>
::execute_refinement
function has been
re-implemented to accommodate future developments. This change
results in different ordering and indexing of lines and
vertices. This leads to a change in the ordering of vertices in
- output files generated by GridOut
+ output files generated by GridOut
for refined grids.
(RH, 2005/03/09)
MGDoFHandler
had trouble
+ Fixed: The class MGDoFHandler
had trouble
when it encountered a triangulation that had unused vertices, something
that happens when one coarsens an existing triangulation. In
that case, it would throw unjustified exceptions. This is now
@@ -988,7 +983,7 @@ inconvenience this causes.
Triangulation::RefinementListener
had only
+ Fixed: The class Triangulation::RefinementListener
had only
virtual abstract functions but no virtual destructor. This caused
warnings with some compilers, and is generally bad practice
anyway. This is now fixed.
@@ -997,7 +992,7 @@ inconvenience this causes.
FETools
::FETools
::compute_embedding_matrices
allows for
automatic computation of embedding matrices under the sole
assumption that the coarse grid space is embedded into the fine
@@ -1015,8 +1010,5 @@ inconvenience this causes.
-Last update $Date$
-
-
+*/
diff --git a/doc/news/5.2.0-vs-6.0.0.html b/doc/news/5.2.0-vs-6.0.0.h
similarity index 89%
rename from doc/news/5.2.0-vs-6.0.0.html
rename to doc/news/5.2.0-vs-6.0.0.h
index 8b59ec7d48..d92a0c0bdb 100644
--- a/doc/news/5.2.0-vs-6.0.0.html
+++ b/doc/news/5.2.0-vs-6.0.0.h
@@ -1,34 +1,30 @@
-
-
-
-
- Changes between versions 5.2 and 6.0
-
-Incompatibilities
@@ -60,10 +56,10 @@ inconvenience this causes.
Changed: When new multigrid transfer classes were introduced,
- the existing class MGTransferSelect
was
+ the existing class MGTransferSelect
was
moved to the new header file
multigrid/mg_transfer_component
. It also received a new
- base class MGTransferComponent
.
+ base class MGTransferComponent
.
(GK 2007/04/26)
begin_line
in 2D and 3D or begin_quad
in 3D. Again, the same applies
- to last_*
and last_*
and end_*
.
Triangulation::create_triangulation_compatibility
- function which takes CellData
in the
+ 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 GeometryInfo
. As a rule-of-thumb:
+ functions in GeometryInfo
. As a rule-of-thumb:
if you want to use non-standard meshes, all occurrences of
face_orientation have to be supplemented by face_flip
and face_rotation.
GridReordering
, which now returns the original
+ GridReordering
, which now returns the original
connectivity if the reordering was not possible.
PETSC_DIR
and
PETSC_ARCH
environment variables but do not wish
- deal.II to be configured for PETSc use, you
+ deal.II to be configured for PETSc use, you
should specify --with-petsc=no
as a flag during
configuration.
Improved: FunctionDerivative
is now
- derived from AutoDerivativeFunction
and implements
+
Improved: FunctionDerivative
is now
+ derived from AutoDerivativeFunction
and implements
gradients as well, giving you automatic second derivatives of a function.
(GK 2007/08/02)
@@ -544,7 +540,7 @@ inconvenience this causes.
(WB 2006/11/10)
Extended: The QGaussLobatto
quadrature
+
Extended: The QGaussLobatto
quadrature
rule computes Legendre-Gauss-Lobatto nodes and quadrature weights.
(Florian Prill 2006/11/02)
@@ -625,7 +621,7 @@ inconvenience this causes.
(WB 2006/07/28)
New: GeometryInfo
offers several new
+
New: GeometryInfo
offers several new
functions, is_inside_unit_cell
with an epsilon parameter to
specify allowable offsets from the actual unit cell,
distance_to_unit_cell
returning the infinity norm of the
@@ -637,7 +633,7 @@ inconvenience this causes.
(Ralf B. Schulz 2006/05/10)
Improved: Improved: Improved: Improved: Improved: The function Improved: The function Fixed: Writing a denormal "NaN" through Improved: The Improved: The Fixed: The Fixed: The Fixed: The Fixed: The Improved: The Improved: The Improved: A new function Improved: A new function Improved: Improved: Changed: The New: The New: The Fixed: The Fixed: The Fixed: The Fixed: The Improved: A simple Improved: A simple Fixed: The Fixed: The Fixed: The Fixed: The New: The class Improved: The class Improved: The class New: the class New: the class Improved: PETSc 2.3.1 (build 16) is now supported by the
linear preconditioner classes. The new PETSc functions
- New: The class New: The class Improved: Improved: Improved: Improved:
Fixed: The
- Improved:
- New: The class
- Improved: The
- Fixed: The
- New: Now the class New: Added function New: Added function Workaround: The class Workaround: The class Fixed: The function Fixed: The function Fixed: Fixed: Fixed: On faces with wrong
- Fixed: The
- Fixed: The
- Extended: There is now a new
- Extended: The Fixed: Corrected Fixed: Corrected
- New: The
- Extended: The
- New: The new function
- New: Function
- Changed: The old version of
- Improved: The functions
- New: There is a new function
- New: There are now functions Improved: Improved:
- Improved: The
- New: There is now a
- Changed: The
- Improved:
- Improved:
- Fixed: The
- Fixed: We had a bug in DataOutBase
::
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.
@@ -645,8 +641,8 @@ inconvenience this causes.
(GK 2006/04/14)
VectorSlice
has new functions
- begin()
and end()
,
+ VectorSlice
has new functions
+ begin()
and end()
,
returning the corresponding vector iterators.
(GK 2006/03/31)
@@ -675,7 +671,7 @@ inconvenience this causes.
(WB 2006/03/14)
Subscriptor
::
::Subscriptor
::list_subscribers
logs all current subscribers of an
object to deallog.
@@ -684,25 +680,25 @@ inconvenience this causes.
LogStream
objects such as
- deallog
erroneously printed zero, rather
+ deallog
erroneously printed zero, rather
than "nan". This is now fixed.
(Luca Heltai, WB 2006/03/07)
TableBase
base class of all
- the Table
classes had an
- >operator()
that takes a TableIndices
object
+ TableBase
base class of all
+ the Table
classes had an
+ >operator()
that takes a TableIndices
object
that represents the entire set of indices at once. However, due to C++
name lookup rules, this operator wasn't accessible through the
- Table
class without explicitly specifying the base class
+ Table
class without explicitly specifying the base class
name. This is now fixed by also providing a similar
- >operator()
in the derived classes.
+ >operator()
in the derived classes.
(WB 2006/02/21)
QGauss
constructor
+ QGauss
constructor
hangs on x86 linux systems when deal.II is run from inside
MATLAB. The reason is that while the processor offers long
double accuracy, MATLAB switches off support for that inside
@@ -718,7 +714,7 @@ inconvenience this causes.
(Christian Kamm, WB 2006/02/21)
ParameterHandler::get_integer
+ ParameterHandler::get_integer
had an erroneous check that the value given for a parameter really
represented an integer. This check always succeeded, even in face of an
error, and a zero value was returned every time the value in the
@@ -727,21 +723,21 @@ inconvenience this causes.
(WB 2006/02/17)
ComponentSelect
class can
+ ComponentSelect
class can
now also handle the case that one wants to select multiple vector
components at once, not only a single one.
(WB 2006/02/12)
TableBase
::
functions which assign this
matrix to the linear combination of one, two or three
matrices. Also there is now a new TableBase
::fill
, filling the whole table with the same
element has been introduced.
(GK 2006/01/18)
DataOutBase
now writes binary
+ DataOutBase
now writes binary
files for OpenDX.
(GK 2006/01/18)
@@ -797,7 +793,7 @@ inconvenience this causes.
New: There are now new get_n_mpi_processes
and get_this_mpi_process
functions in the
- Utilities::System
namespace. In case
+ Utilities::System
namespace. In case
of a code not running in parallel, they simply return 1 and 0,
respectively.
@@ -813,7 +809,7 @@ inconvenience this causes.
CompressedBlockSparsityPattern
has been renamed to
- BlockCompressedSparsityPattern
to be
+ 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,
but its use is deprecated.
@@ -821,7 +817,7 @@ inconvenience this causes.
(WB 2007/06/17)
CompressedSetSparsityPattern
+ CompressedSetSparsityPattern
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
@@ -833,14 +829,14 @@ inconvenience this causes.
(Oliver Kayser-Herold, WB 2007/06/03)
SolverBicgstab
class
+ SolverBicgstab
class
did not handle hitting on the solution early very
gracefully (it threw an exception). This is now fixed.
(Roger Young 2007/03/07)
SparseDirectMA27
class allows
+ SparseDirectMA27
class allows
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
@@ -851,13 +847,13 @@ inconvenience this causes.
(WB 2007/02/09)
print_formatted
- function has been added to SparseMatrixEZ
.
+ print_formatted
+ function has been added to SparseMatrixEZ
.
(Moritz Allmaras 2007/02/08)
SparseDirectMA27
+ SparseDirectMA27
class works for symmetric matrices and had a check to make sure the
matrix is indeed symmetric. However, the check compared entries for
equality, something one should not do for floating point numbers. It now
@@ -866,7 +862,7 @@ inconvenience this causes.
(WB 2006/12/21)
FullMatrix::invert
+ FullMatrix::invert
function would return wrong results if one tried to invert a
matrix of dimension smaller than 5 in situ. This is now fixed.
@@ -893,21 +889,21 @@ inconvenience this causes.
PointerMatrixVector
implements the functions
- vmult
and vmult
and Tvmult
for a 1xn-matrix represented by
a single vector.
(GK 2006/09/17)
SolverCG
can
+ SolverCG
can
now estimate the condition number of the linear system using TridiagonalMatrix
and LAPACK.
(GK 2006/09/06)
TridiagonalMatrix
+ TridiagonalMatrix
has been introduced together with its basic methods, including an
eigenvalue solver for the symmetric case (LAPACK).
@@ -916,13 +912,13 @@ inconvenience this causes.
PCFactorSetXXX
are used.
+ PCFactorSetXXX
are used.
(Florian Prill, 2006/08/04)
TransposeMatrix
- modeled after PointerMatrix
swaps the
- vmult
functions such that its effect is
+ TransposeMatrix
+ modeled after PointerMatrix
swaps the
+ vmult
functions such that its effect is
the transpose of the matrix it points to.
(GK 2006/07/07)
@@ -935,7 +931,7 @@ inconvenience this causes.
(WB 2006/06/16)
PointerMatrixAux
now has a
+ PointerMatrixAux
now has a
default constructor and a function for setting the VectorMemory
object.
@@ -987,9 +983,9 @@ inconvenience this causes.
(WB 2006/03/30)
BlockSparsityPattern
can be
+ BlockSparsityPattern
can be
initialized directly using the vector generated by
- DoFTools
::DoFTools
::compute_row_length_vector
.
(GK 2006/03/30)
@@ -1011,7 +1007,7 @@ inconvenience this causes.
class="member">equVector
::equ
+ class="class">Vectorequ
function for three vectors.
(RH 2006/02/21)
@@ -1020,7 +1016,7 @@ inconvenience this causes.
SolverMinRes
class did not work
- with the BlockVector
class.
+ with the BlockVector
class.
This is now fixed.
(Luca Heltai 2006/02/19)
@@ -1049,7 +1045,7 @@ inconvenience this causes.
BlockMatrixArray
::BlockMatrixArray
::enter_aux
allows using matrices without
adding vector multiplication by using PointerMatrixAux
.
@@ -1058,7 +1054,7 @@ inconvenience this causes.
PointerMatrixAux
was
+ New: The class PointerMatrixAux
was
introduced for use with matrix classes lacking the adding
vector multiplication functions. It implements these by using
its own auxiliary vector.
@@ -1067,8 +1063,8 @@ inconvenience this causes.
FilteredMatrix
class
- was able to filter only the SparseMatrix
+ Improved: The FilteredMatrix
class
+ was able to filter only the SparseMatrix
matrix class.
A new (faster) version is now in its place with the same interface
that is able to perform such a filter on anything that provides
@@ -1084,7 +1080,7 @@ inconvenience this causes.
class might allow reusing temporary vectors, and thus reduce
the overhead of repeatedly allocating and freeing
memory. However, almost all instances of using these classes
- used the PrimitiveVectorMemory
+ used the PrimitiveVectorMemory
class. The solver class have now been changed so that if one
omits the respective argument, they fall back to using such a
memory object. Also, all example programs that did not
@@ -1096,7 +1092,7 @@ inconvenience this causes.
SparseMatrix
iterators had a
+ Fixed: The SparseMatrix
iterators had a
problem when one wrote code like iterator->value()=0
(i.e. with a zero integer, rather than a floating point number on the
right), in that that opened up a second conversion sequence and the
@@ -1106,9 +1102,9 @@ inconvenience this causes.
SparseILU
supports
- also the Tvmult
method. This feature
- allows the straightforward use of SparseILU
+ New: Now the class SparseILU
supports
+ also the Tvmult
method. This feature
+ allows the straightforward use of SparseILU
as a multigrid smoother within the framework.
(Oliver Kayser-Herold 2005/09/15)
@@ -1259,7 +1255,7 @@ inconvenience this causes.
(WB 2007/02/20)
GridGenerator
::
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.
@@ -1267,7 +1263,7 @@ inconvenience this causes.
(Luca Heltai 2007/02/15)
GridOut
::
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
@@ -1279,7 +1275,7 @@ inconvenience this causes.
DoFTools
::
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.
@@ -1295,8 +1291,8 @@ inconvenience this causes.
(WB 2007/02/09)
MatrixCreator
::create_mass_matrix
and
+
::MatrixCreator
::create_mass_matrix
and
create_laplace_matrix
computed wrong values for the right
hand sides. This has been fixed.
@@ -1315,11 +1311,11 @@ inconvenience this causes.
especially for higher order elements. This change corresponds
to an extension of the intermediate format for graphics.
- Fixed: Using the given Mapping
to
+ Fixed: Using the given Mapping
to
obtain function values in DataOut
::build_patches()
also fixes a bug for
- FE_RaviartThomas
and FE_RaviartThomas
and FE_ABF
elements, which need to evaluate the
function values on the real (mapped) cell.
@@ -1329,7 +1325,7 @@ inconvenience this causes.
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
and systems of FE_Q
this works now, for other finite elements the
reordering vector still has to be implemented.
@@ -1337,7 +1333,7 @@ inconvenience this causes.
Triangulation
::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
@@ -1351,7 +1347,7 @@ inconvenience this causes.
Triangulation
::
+ Fixed: The
Triangulation
::
MeshSmoothing
flag patch_level_1
wrongly produced cells
on level 0 during coarsening_and_refinement
, which is now fixed.
@@ -1359,8 +1355,8 @@ inconvenience this causes.
Triangulation
- ::MeshSmoothing
flag coarsest_level_1
+ Extended: There is now a new Triangulation
+ ::MeshSmoothing
flag coarsest_level_1
which ensures that after coarsening_and_refinement
there are no
cells on level 0, i.e. the coarsest level is 1, if the triangulation had
coarsest_level_1
already before.
@@ -1369,7 +1365,7 @@ inconvenience this causes.
GridIn
class can now
+ Extended: The GridIn
class can now
read in tecplot files in ASCII format (block and point format,
ordered and unstructured grids, format specifiers acccording to
Tecplot 10 and younger versions). At the moment the
@@ -1395,7 +1391,7 @@ inconvenience this causes.
class="class">GridToolsdelete_duplicated_vertices
that deletes
duplicate vertices which can occur if structured grids are read
- into deal.II, leading to unwanted interior
+ into deal.II, leading to unwanted interior
boundaries. In order to reduce the effort of the quadratic
algorithm, a list of vertices to be considered can be supplied
if available.
@@ -1413,8 +1409,8 @@ inconvenience this causes.
(Yaqi Wang 2006/11/15, 2006/12/29)
clone
method
- of FE_DGQ
class for non-equidistant
+ clone
method
+ of FE_DGQ
class for non-equidistant
support points.
(Florian Prill 2006/10/31)
@@ -1443,7 +1439,7 @@ inconvenience this causes.
ConstraintMatrix
class did not
+ New: The ConstraintMatrix
class did not
allow that one degree of freedom was constrained against another DoF
that was itself constrained. However, this is necessary for the
implementation of hp methods and is now allowed. Arbitrarily long chains
@@ -1481,7 +1477,7 @@ inconvenience this causes.
VectorTools::project
functions
+ Extended: The VectorTools::project
functions
are now also implemented for 1d.
(WB 2006/08/08)
@@ -1529,7 +1525,7 @@ inconvenience this causes.
FiniteElementBase
::FiniteElementBase
::n_dofs_per_object
returns either
dofs_per_vertex
, dofs_per_line
,
dofs_per_quad
, ..., depending on the explicitly
@@ -1566,7 +1562,7 @@ inconvenience this causes.
VectorTools
::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
@@ -1588,7 +1584,7 @@ inconvenience this causes.
GridTools
::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
@@ -1600,10 +1596,10 @@ inconvenience this causes.
VectorTools
::point_value
and VectorTools
::VectorTools
::point_value
and VectorTools
::point_difference
now can also use arbitrary
- mappings, using the new GridTools
::GridTools
::find_active_cell_around_point
algorithm.
(Ralf B. Schulz, 2006/05/11)
@@ -1703,7 +1699,7 @@ inconvenience this causes.
FiniteElement
::FiniteElement
::face_to_equivalent_cell_index
that can
convert a face index of a degree of freedom into a
corresponding cell index.
@@ -1712,14 +1708,14 @@ inconvenience this causes.
VectorTools
::VectorTools
::point_value
that evaluate the value of a
finite element function at a given point inside the domain.
(WB 2006/03/06)
GridOut
now has functions for
+ GridOut
now has functions for
declaring and parsing parameters in a ParameterHandler
, like used in DataOut_Interface
for a long time.
@@ -1728,7 +1724,7 @@ inconvenience this causes.
Triangulation
, Triangulation
, PersistentTriangulation
, DoFHandler
, hp::DoFHandler
and MappingQ1
objects can be avoided.
- Similar to StaticMappingQ1
::StaticMappingQ1
::mapping
there is now also an object hp::StaticMappingQ1
::mapping_collection
of type
function. Previously a private function in GridOut
::GridOut
::write_gmsh
function to write in the gmsh
format. It has the same features of the write_ucd one.
@@ -1775,13 +1771,13 @@ inconvenience this causes.
hp::FECollection
::hp::FECollection
::get_fe
, hp::QCollection
::get_quadrature
and hp::MappingCollection
::get_mapping
functions are now renamed to
- the standard operator[]
+ the standard operator[]
function. Similarly, the FECollection
::n_finite_elements
, n_quadratures
and MappingCollection
::n_mappings
functions are now renamed to
- the standard size()
function.
+ the standard size()
function.
(RH 2006/02/10)
GridGenerator
::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.
@@ -1804,8 +1800,8 @@ inconvenience this causes.
FiniteElementData
and
- FiniteElement
now support the
+ Improved: FiniteElementData
and
+ FiniteElement
now support the
concept of blocks along with components. See the glossary for
the difference.
@@ -1813,7 +1809,7 @@ inconvenience this causes.
MGDoFHandler
::MGDoFHandler
::distribute_dofs
and renumber
functions could not handle
coarsened grids (unused vertices, faces and cells). This is now
@@ -1848,7 +1844,7 @@ inconvenience this causes.
DataOut::build_patches
+ Fixed: We had a bug in DataOut::build_patches
that, when used in multithreaded mode, caused an exception to be
thrown. In particular, this happened when the step-14 program was run on
dual processor machines and the library was compiled for
@@ -1870,7 +1866,7 @@ inconvenience this causes.
class="member">GridTools::delete_unused_verticesGridIn
it has now been moved to and made
- public in GridTools
.
+ public in GridTools
.
(RH 2005/09/28)
-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
+This is the list of changes made between the deal.II releases listed above.
made to the three sub-libraries base,
lac, and deal.II, as well as
changes to the general infrastructure,
diff --git a/doc/news/6.1.0-vs-6.2.0.h b/doc/news/6.1.0-vs-6.2.0.h
index 8dfc1bc732..e91559b24e 100644
--- a/doc/news/6.1.0-vs-6.2.0.h
+++ b/doc/news/6.1.0-vs-6.2.0.h
@@ -18,8 +18,7 @@
* @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
-deal.II version 6.1 and version 6.2. It is subdivided into changes
+This is the list of changes made between the deal.II releases listed above.
made to the three sub-libraries base,
lac, and deal.II, as well as
changes to the general infrastructure,
diff --git a/doc/news/6.2.0-vs-6.2.1.h b/doc/news/6.2.0-vs-6.2.1.h
index d1fa2537e8..e6e1ee3f23 100644
--- a/doc/news/6.2.0-vs-6.2.1.h
+++ b/doc/news/6.2.0-vs-6.2.1.h
@@ -18,8 +18,7 @@
* @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
-deal.II version 6.2.0 and version 6.2.1:
+This is the list of changes made between the deal.II releases listed above.
-This is the list of changes made between the release of
-deal.II version 6.2 and version 6.3. It is subdivided into changes
+This is the list of changes made between the deal.II releases listed above.
made to the three sub-libraries base,
lac, and deal.II, as well as
changes to the general infrastructure,
diff --git a/doc/news/6.3.0-vs-6.3.1.h b/doc/news/6.3.0-vs-6.3.1.h
index 7081084d21..3b369788e8 100644
--- a/doc/news/6.3.0-vs-6.3.1.h
+++ b/doc/news/6.3.0-vs-6.3.1.h
@@ -18,8 +18,7 @@
* @page changes_between_6_3_0_and_6_3_1 Changes between Version 6.3.0 and 6.3.1
-This is the list of changes made between the release of
-deal.II version 6.3.0 and version 6.3.1:
+This is the list of changes made between the deal.II releases listed above.
diff --git a/doc/news/6.3.0-vs-7.0.0.h b/doc/news/6.3.0-vs-7.0.0.h
index 54ed1eb977..33c730186a 100644
--- a/doc/news/6.3.0-vs-7.0.0.h
+++ b/doc/news/6.3.0-vs-7.0.0.h
@@ -18,8 +18,7 @@
* @page changes_between_6_3_and_7_0 Changes between Version 6.3 and 7.0
-This is the list of changes made between the release of
-deal.II version 6.3.0 and that of version 7.0.0. It is subdivided into changes
+This is the list of changes made between the deal.II releases listed above.
made to the three sub-libraries base,
lac, and deal.II, as well as
changes to the general infrastructure,
diff --git a/doc/news/7.0.0-vs-7.1.0.h b/doc/news/7.0.0-vs-7.1.0.h
index 007be1465b..8b122f684b 100644
--- a/doc/news/7.0.0-vs-7.1.0.h
+++ b/doc/news/7.0.0-vs-7.1.0.h
@@ -18,8 +18,7 @@
* @page changes_between_7_0_and_7_1 Changes between Version 7.0 and 7.1
-This is the list of changes made between the release of
-deal.II version 7.0.0 and that of 7.1.0.
+This is the list of changes made between the deal.II releases listed above.
All entries are signed with the names of the author.
-This is the list of changes made between the release of
-deal.II version 7.1.0 and that of 7.2.0.
+This is the list of changes made between the deal.II releases listed above.
All entries are signed with the names of the author.
-This is the list of changes made between the release of
-deal.II version 7.2.0 and that of 7.3.0.
+This is the list of changes made between the deal.II releases listed above.
All entries are signed with the names of the author.
-This is the list of changes made between the release of
-deal.II version 7.3.0 and that of 8.0.0.
+This is the list of changes made between the deal.II releases listed above.
All entries are signed with the names of the authors.
-This is the list of changes made between the release of
-deal.II version 8.0.0 and that of 8.1.0.
+This is the list of changes made between the deal.II releases listed above.
All entries are signed with the names of the author.