From: Daniel Arndt
double
, float
,
* and in some cases std::complex@
and
* std::complex@
.
- *
+ *
*
* @section Inst2 A few instantiations, most of which are known
*
@@ -86,7 +86,7 @@
* interfaces, including vector types that are not part of the library but
* possibly defined in an application program. In such a case, applications
* can instantiate these templates by hand as described in the next section.
- *
+ *
*
* @subsection Inst2c Creating new instances
*
@@ -106,7 +106,7 @@
* template class XXXXupdate_gradients
flag
* (for $\nabla\varphi_i(\bf x_q)$) and the update_JxW_values
@@ -120,7 +120,7 @@
* Jacobian matrix, $J^{-1}(\bf x_q)$ (and not just the determinant of the matrix),
* and to compute the inverse of the Jacobian, it is also necessary to compute
* the Jacobian matrix first.
- *
+ *
* Since these are requirements that are not important to the user, it
* is not necessary to specify this in user code. Rather, given a set
* of update flags, the FEValues object first asks the finite element
@@ -144,15 +144,15 @@
* store some temporary information that can be computed once and for
* all, and these flags will be used when re-computing data on each
* cell we will visit later on.
- *
- *
+ *
+ *
* update_once
and update_each
(though these names
@@ -183,23 +183,23 @@
* set update_once=update_values
and
* update_each=0
, whereas the Raviart-Thomas element will
* do it the other way around.
- *
+ *
* These sets of flags are intended to be mutually exclusive. There is,
* on the other hand, nothing that ever provides this decomposition to
* anything outside the mapping or finite element classes -- it is a purely
* internal decomposition.
- *
- *
+ *
+ *
* OpenCASCADE is a diff --git a/doc/external-libs/trilinos.html b/doc/external-libs/trilinos.html index e5e23743b9..5752cbb275 100644 --- a/doc/external-libs/trilinos.html +++ b/doc/external-libs/trilinos.html @@ -128,28 +128,28 @@
- Note: At the time of writing (November 2016) Trilinos (at least up to
- v12.8.1) cannot link against LAPACK 3.6.0 or later, due to two symbols
- that were deprecated (and removed by default) in LAPACK 3.6.0 (see the
+ Note: At the time of writing (November 2016) Trilinos (at least up to
+ v12.8.1) cannot link against LAPACK 3.6.0 or later, due to two symbols
+ that were deprecated (and removed by default) in LAPACK 3.6.0 (see the
- release notes). To fix this, edit the Trilinos file
- packages/epetra/src/Epetra_LAPACK_wrappers.h
and change the
+ release notes). To fix this, edit the Trilinos file
+ packages/epetra/src/Epetra_LAPACK_wrappers.h
and change the
lines
- + #define DGGSVD_F77 F77_BLAS_MANGLE(dggsvd,DGGSVD) #define SGGSVD_F77 F77_BLAS_MANGLE(sggsvd,SGGSVD)to
- + #define DGGSVD_F77 F77_BLAS_MANGLE(dggsvd3,DGGSVD3) #define SGGSVD_F77 F77_BLAS_MANGLE(sggsvd3,SGGSVD3)- before installing Trilinos. (Credit for this fix goes to + before installing Trilinos. (Credit for this fix goes to this page.) - +
Trilinos sometimes searches for other libraries but can't find
them if they are not in the usual directories or have other
@@ -176,7 +176,7 @@
this page for Trilinos 11.8). Most of them are external
packages to Trilinos and you will need to tell Trilinos configuration
- scripts that you want to use them, for example via the
+ scripts that you want to use them, for example via the
TrilinosWrappers::SolverDirect
class. This can be tricky,
but adding defines similar to the following to the cmake command line
will achieve the goal to enable the UMFPACK and SuperLU/SuperLUDist
diff --git a/doc/news/2.0.0-vs-3.0.0.h b/doc/news/2.0.0-vs-3.0.0.h
index 75e7e7bcb1..4a260622a0 100644
--- a/doc/news/2.0.0-vs-3.0.0.h
+++ b/doc/news/2.0.0-vs-3.0.0.h
@@ -45,26 +45,26 @@ The library is written for research purposes and offers many features:
refinement strategies based on local error indicators and error
estimators.
Support for a variety of finite elements, including Lagrange +
Support for a variety of finite elements, including Lagrange elements of order one through four, and discontinuous elements.
Extensive documentation: all documentation is available online in a - logical tree structure to allow fast access to the information you + logical tree structure to allow fast access to the information you need. If printed it comprises about 200 pages of tutorials, several reports, and far more than 1,000 pages of programming interface - documentation with explanations of all classes, functions, and + documentation with explanations of all classes, functions, and variables.
Modern software techniques that make access to the complex data - structures and algorithms as transparent as possible. The use of + structures and algorithms as transparent as possible. The use of object oriented programming allows for program structures similar to the structures in mathematical analysis.
Fast algorithms that enable you to solve problems with up to several - millions of degrees of freedom quickly. As opposed to programming + millions of degrees of freedom quickly. As opposed to programming symbolic algebra packages the penalty for readability is low.
-Support for several output formats, including some common formats +
Support for several output formats, including some common formats for visualization of scientific data.
Support for a variety of computer platforms, including multi- diff --git a/doc/news/3.0.0-vs-3.0.1.h b/doc/news/3.0.0-vs-3.0.1.h index 640dcf5540..c2e75f695a 100644 --- a/doc/news/3.0.0-vs-3.0.1.h +++ b/doc/news/3.0.0-vs-3.0.1.h @@ -33,7 +33,7 @@ All entries are signed with the names of the author.
Fix: getting the support points from system finite elements
(class FESystem
) resulted in an
- exception.
+ exception.
(WB 2000/05/10)
- Fix: slight bug in
+ Fix: slight bug in
DataOut::build_patches
in multithreaded mode fixed.
@@ -54,7 +54,7 @@ All entries are signed with the names of the author.
- Fix:
+ Fix:
SparsityPattern::print_gnuplot
wrote rows and columns exchanged. Since most matrices have
symmetric sparsity patterns, this has gone unnoticed by now.
@@ -63,8 +63,8 @@ All entries are signed with the names of the author.
- Fixed: the
- common/scripts/make_dependencies.pl
+ Fixed: the
+ common/scripts/make_dependencies.pl
script that sets up the dependencies for the make files had a
problem when the path to the library included special characters
such as `+'. This is now fixed.
diff --git a/doc/news/3.0.0-vs-3.1.0.h b/doc/news/3.0.0-vs-3.1.0.h
index 6634416153..2f0602b5f2 100644
--- a/doc/news/3.0.0-vs-3.1.0.h
+++ b/doc/news/3.0.0-vs-3.1.0.h
@@ -41,7 +41,7 @@ All entries are signed with the names of the author.
- New: In multithreading mode, the compile flags now also have
+ New: In multithreading mode, the compile flags now also have
_REENTRANT
defined. If this flag
is defined, then the standard Unix headers also declare
reentrant versions (with suffix _r
)
@@ -65,13 +65,13 @@ All entries are signed with the names of the author.
New: the step-9
example program is
now ready, showing several advanced programming techniques in
- deal.II.
+ deal.II.
(WB 2000/07/18)
- Changed: deal.II now uses the
+ Changed: deal.II now uses the
kdoc2
program to generate the API
documentation. This makes up for much nices documentation and
also works better than the previous kdoc1
.
@@ -92,8 +92,8 @@ All entries are signed with the names of the author.
- Fixed: the
- common/scripts/make_dependencies.pl
+ Fixed: the
+ common/scripts/make_dependencies.pl
script that sets up the dependencies for the make files had a
problem when the path to the library included special characters
such as `+'. This is now fixed.
@@ -126,16 +126,16 @@ All entries are signed with the names of the author.
Improved: the configure
script is
now used to select the compiler options. Previously, selection
- of compiler options was done both in
+ of compiler options was done both in
configure
as well as in the global
- options Makefile
+ options Makefile
common/Make.global_options
.
(WB 2000/06/02)
- Improved: Dependence on the files
+ Improved: Dependence on the files
forward_declarations.h
has been widely
removed to improve compilation time
@@ -144,7 +144,7 @@ All entries are signed with the names of the author.
- Fix: configure
now uses
+ Fix: configure
now uses
config.guess
to determine the
operating system and hardware platform.
@@ -186,7 +186,7 @@ All entries are signed with the names of the author.
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
+ and other objects can be found the
MemoryConsumption
namespace.
(WB 2000/11/27)
@@ -209,7 +209,7 @@ All entries are signed with the names of the author.
faces in 3d computations).
(WB 2000/09/07)
-
New: There is a new distance
function
@@ -217,9 +217,9 @@ All entries are signed with the names of the author.
distance between two points.
(Ralf Hartmann 2000/09/06)
-
+
New: Timer
now uses the system
function getrusage (RUSAGE_CHILDREN,
.)
that is need in multithreading. But still the
(Ralf Hartmann 2000/08/25)
-
New: There are now a set of functions
@@ -236,10 +236,10 @@ All entries are signed with the names of the author.
product of tensors.
(WB 2000/07/23)
-
- New: The classes
+ New: The classes
Patterns::Integer
and Patterns::Double
now allow that
a range may be specified in which the parameter shall
@@ -321,7 +321,7 @@ All entries are signed with the names of the author.
- New: There are now functions
+ New: There are now functions
SparsityPattern::symmetrize
and
SparseMatrix::symmetrize
that
generate a symmetric matrix from a non-symmetric one.
@@ -338,13 +338,13 @@ All entries are signed with the names of the author.
(WB 2000/11/27)
+
New:
SparseMatrix
returns the number of entries that are actually nonzero.
(Ralf Hartmann 2000/11/22)
-
Fixed: unlike announced in the docs, the
@@ -353,7 +353,7 @@ All entries are signed with the names of the author.
fixed now.
(GK 2000/08/28)
-
Improved: PreconditionBlockSOR
SolverBicgstab::AdditionalData
.
(GK 2000/07/07)
-
New: SolverRichardson
has a
@@ -388,13 +388,13 @@ All entries are signed with the names of the author.
(GK 2000/06/30)
+
New: For recognizing a diverging solver before the maximum
- number of steps is reached,
- SolverControl
returns
+ number of steps is reached,
+ SolverControl
returns
failure
also if the residual
increases over the start residual by a specific factor. This
- factor is given to the SolverControl
+ 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
@@ -429,7 +429,7 @@ All entries are signed with the names of the author.
- Fix:
+ Fix:
SparsityPattern::print_gnuplot
wrote rows and columns exchanged. Since most matrices have
symmetric sparsity patterns, this has gone unnoticed by now.
@@ -438,7 +438,7 @@ All entries are signed with the names of the author.
- Fix: the
+ Fix: the
FullMatrix::Tvmult
function
suffered from the same problems as the
FullMatrix::Tmmult
function. This
@@ -464,10 +464,10 @@ All entries are signed with the names of the author.
New: BlockIndices
: Class that
manages the conversion of global indices into a block
- vector/matrix/... to the indices local to each of the blocks.
+ vector/matrix/... to the indices local to each of the blocks.
(WB 2000/05/08)
-
New: BlockSparsityPattern
and
@@ -475,23 +475,23 @@ All entries are signed with the names of the author.
represent matrices that are composed of sparse matrices.
(WB 2000/05/08)
-
- Fix: the
+ Fix: the
FullMatrix::mmult
and
FullMatrix::Tmmult
code don't
resize their output argument any more, as this is not common
- style in the library. Furthermore,
+ style in the library. Furthermore,
FullMatrix::Tmmult
was utterly
- broken.
+ broken.
(WB 2000/05/08)
Change: the matrix_norm
functions
- of sparse and full matrices are renamed to
+ of sparse and full matrices are renamed to
matrix_norm_square
, since they in
fact return the square of the norm. This should avoid confusion
in some cases.
@@ -500,7 +500,7 @@ All entries are signed with the names of the author.
- Fix: the ``copy-like'' constructor of
+ Fix: the ``copy-like'' constructor of
SparsityPattern
that copies another
object and adds some off-diagonals had a bug that caused an
exception in some cases. This is now fixed.
@@ -519,7 +519,7 @@ All entries are signed with the names of the author.
- New: there are now functions Vector::swap
+ 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
@@ -537,7 +537,7 @@ All entries are signed with the names of the author.
Change: the solver classes in LAC lost their first template
- argument. Their names are now
+ argument. Their names are now
SolverXX<VECTOR>
, where
XX
denotes the name of the solver
(e.g. CG, GMRES, etc). Furthermore, the
@@ -587,17 +587,17 @@ All entries are signed with the names of the author.
Extend: DoFTools::extract_boundary_dofs
now allows to also specify which boundary conditions shall be
- considered.
+ considered.
(WB 2000/12/04)
- New: some arguments of the functions
+ New: some arguments of the functions
DoFHandler::n_boundary_dofs
,
DoFTools::extract_boundary_dofs
,
and
- DoFTools::map_dof_to_boundary_indices
+ 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
@@ -655,9 +655,9 @@ All entries are signed with the names of the author.
class can handle boundary information in 3d as well
(i.e. lines and quads in 3d with special material IDs).
- (Michael
+ (Michael
Stadler 2000/10/11)
-
Extended: The GridIn
@@ -666,7 +666,7 @@ All entries are signed with the names of the author.
(Michael
Stadler 2000/10/11)
-
New: The GridRefinement::refine_and_coarsen_optimize
@@ -674,7 +674,7 @@ All entries are signed with the names of the author.
refinement and coarsening.
(Thomas Richter 2000/10/10)
-
Extended: The GridIn::delete_unused_vertices
@@ -688,14 +688,14 @@ All entries are signed with the names of the author.
to the triangulation object.
(WB 2000/09/26)
-
New: The GridIn
class can now read the basics of grids in DB Mesh format.
(WB 2000/09/26)
-
Extended: The KellyErrorEstimator
@@ -704,7 +704,7 @@ All entries are signed with the names of the author.
DoFHandler
object.
(WB 2000/09/11)
-
New: The DataOut_Faces
class allows to
@@ -713,10 +713,10 @@ All entries are signed with the names of the author.
cuts through the domain.
(WB 2000/09/07)
-
- Removed: The
+ Removed: The
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 framework of classes around
@@ -738,7 +738,7 @@ All entries are signed with the names of the author.
- Changed: The
+ Changed: The
map_dof_to_boundary_index
functions have been moved from the DoFHandler
to the DoFTools
class, in order to
@@ -817,7 +817,7 @@ All entries are signed with the names of the author.
were dormant, since the values of finite elements are always
computed for the presently available Lagrange elements, but
would have been activated once there are other classes of
- elements.
+ elements.
(Ralf Hartmann 2000/07/20)
New: The new function
- Fix: slight bug in
+ Fix: slight bug in
- Removed: The obsolete
+ Removed: The obsolete
get_face
of FEFaceValues
and
DataOut::build_patches
in multithreaded mode fixed.
@@ -883,7 +883,7 @@ All entries are signed with the names of the author.
MatrixCreator::create_interpolation_matrix
function is now removed.
- Changed: enum
- MeshSmoothing
is moved into the
+ Changed: enum
+ MeshSmoothing
is moved into the
Triangulation
class.
(Ralf Hartmann 2000/05/18)
+
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
@@ -941,14 +941,14 @@ All entries are signed with the names of the author.
- Changed: the
+ Changed: the
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
pattern, or if the user (through a new flag) tells the function
that this is not necessary, for example if the matrix itself is
- non-symmetric.
+ non-symmetric.
@@ -997,40 +997,40 @@ All entries are signed with the names of the author.
- Changed: The computation of the Jacobian matrices in the
+ Changed: The computation of the Jacobian matrices in the
FEValues
class is now done more
efficiently. The speedup is in the range of a factor of 40 for
- 3D.
+ 3D.
(John Burnell, WB 2000/05/16)
+
Change: DoFTools::make_hanging_node_constraints ()
does not use the user flags any more, and can thus run in
- parallel more than once.
+ parallel more than once.
(WB 2000/05/15)
+
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
+ allows to use this function for the usual
+ SparsityPattern
, or for
BlockSparsityPattern
arguments.
(WB 2000/05/15)
+
New: DoFTools::extract_hanging_node_dofs ()
identifies nodes that will be constrained by hanging node constraints.
(WB 2000/05/12)
+
New: DoFRenumbering::sort_selected_dofs_back ()
sorts selected degrees of freedom to the end of the index
range.
@@ -1038,7 +1038,7 @@ All entries are signed with the names of the author.
(WB 2000/05/12)
+
Change: the return value of
DoFHandler::max_couplings_between_dofs ()
is bounded by DoFHandler::n_dofs()
.
@@ -1046,23 +1046,23 @@ All entries are signed with the names of the author.
(Ralf Hartmann 2000/05/11)
+
New: FEValuesBase::get_cell ()
returns present cell.
(Ralf Hartmann 2000/05/11)
+
Fix: FESystem::reinit()
generated
- an exception if update_support_points
+ an exception if update_support_points
was set.
(WB 2000/05/10)
- New: 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)
@@ -1077,7 +1077,7 @@ All entries are signed with the names of the author.
- New: DoFTools::extract_boundary_dofs
+ New: DoFTools::extract_boundary_dofs
finds all degrees of freedom which are at the boundary and belong to
specified components.
@@ -1085,7 +1085,7 @@ All entries are signed with the names of the author.
- New: DoFTools::compute_intergrid_constraints
+ New: DoFTools::compute_intergrid_constraints
allows to use different discretization grids for different
variables.
@@ -1095,7 +1095,7 @@ All entries are signed with the names of the author.
New: DataOut::clear_data_vectors
allows to re-use an object without deleting the DoFHandler
.
+ class="class">DoFHandler.
(GK 2000/04/05)
- Fixed: When using Neuman boundary functions in the
+ Fixed: When using Neuman boundary functions in the
KellyErrorEstimator
class, it was
assumed that the function object had Function::vector_value
overloaded, even
@@ -62,7 +62,7 @@ All entries are signed with the names of the author.
(WB 2001/04/09)
New/Fixed: Now there exists a new Triangulation
::
(RH 2001/04/03)
Fixed: Missing
+
Removed: The explicit instantiations of
New: The finite element
classes have been redesigned from scratch to allow also
@@ -102,7 +102,7 @@ All entries are signed with the names of the author.
to higher degree.
+
Furthermore we have totally reimplemented the mapping
between unit and real cell. In future we won't be restricted
to Q1 mapping any more, but we will have
@@ -141,8 +141,8 @@ All entries are signed with the names of the author.
- New: There is now some support to include and use routines from the
- Harwell Subroutine Library.
+
New: Color function
+
New: Function
+
New: classes
- New: There is now a function
-
- New: There are now functions
+ New: There are now functions
+
New: The functions ucd
is now added to the list of
supported output formats returned by
-
SparseMatrix<long double>
are removed as a
prerelease of gcc3.0 fails to compile it. Now the user of deal.II/include/grid/tria_accessor.templates.h
(which contains some inline functions for triangulation
- accessor classes) into
+ accessor classes) into
deal.II/include/grid/tria_accessor.h
to work
around a problem with gcc3.0 which does not place a copy of
these functions into the library. Previously we only included
diff --git a/doc/news/3.1.0-vs-3.2.0.h b/doc/news/3.1.0-vs-3.2.0.h
index 2ab8e870dd..d606024707 100644
--- a/doc/news/3.1.0-vs-3.2.0.h
+++ b/doc/news/3.1.0-vs-3.2.0.h
@@ -91,7 +91,7 @@ All entries are signed with the names of the author.
FiniteElements
and Mappings
-
+
(WB 2001/01/30)
@@ -165,14 +165,14 @@ All entries are signed with the names of the author.
base
-
DataOutBase::EpsFlags::reverse_grey_scale_color_function
.
(WB 2001/08/24)
QProjector::project_to_child
generates quadrature formulae which act on the area which a
child would occupy.
@@ -191,7 +191,7 @@ All entries are signed with the names of the author.
(WB 2001/07/18)
FourierSineFunction
and FourierCosineFunction
,
resembling one mode of a Fourier decomposition. Classes Vector
and
BlockVector
now have member functions
operator*=
which scale the vectors
- by a constant factor. These functions are aliases for the
+ by a constant factor. These functions are aliases for the
scale
member functions except that
they return a reference to themselves.
@@ -423,8 +423,8 @@ All entries are signed with the names of the author.
FullMatrix::precondition_Jacobi
. The
+ New: There is now a function
+ FullMatrix::precondition_Jacobi
. The
PreconditionJacobi
class is
therefore now also applicable with the full matrix class.
@@ -476,13 +476,13 @@ All entries are signed with the names of the author.
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
+ maximal row length, then calling
SparsityPattern::compress
etc.
(WB 2001/05/07)
@@ -542,7 +542,7 @@ All entries are signed with the names of the author.
(GK 2001/03/29)
FullMatrix
::mmult
and Tmmult
now have an additional
@@ -561,7 +561,7 @@ All entries are signed with the names of the author.
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.
+ post-processing of right hand side and slution, respectively.
(GK 2001/03/22)
(RH 2001/03/14)
+ +
New: class BlockMatrixArray<MATRIX>
implements
a block matrix based on an array of matrix pointers. Since this
@@ -590,10 +590,10 @@ All entries are signed with the names of the author.
- New: There is now some support to include and use routines from the
- Harwell Subroutine Library, and support
- classes
+ classes
SparseDirectMA27
and
SparseDirectMA47
for the sparse direct solvers MA27 and MA47.
@@ -608,28 +608,28 @@ All entries are signed with the names of the author.
+
New: Class MappingQ1Eulerian
implementing an Eulerian mapping.
(Michael Stadler 2001/09/24)
+
New: VectorTools::create_boundary_right_hand_side
integrates boundary forces for inhomogeneous Neumann boundary values.
(WB 2001/09/13)
+
New: DoFTools::make_flux_sparsity_pattern
now exists also for 1d.
(WB 2001/09/03)
+
New: There are now two functions
FETools::hierarchic_to_lexicographic_numbering
@@ -641,7 +641,7 @@ All entries are signed with the names of the author.
(WB 2001/08/31)
+
New: ConstraintMatrix::close
now simply returns instead of throwing an exception, if the
matrix was already closed.
@@ -694,7 +694,7 @@ All entries are signed with the names of the author.
New: Implement
DoFTools::make_sparsity_pattern
,
DoFTools::make_boundary_sparsity_pattern
,
- and
+ and
ConstraintMatrix::condense
to work on
the CompressedSparsityPattern
and
CompressedBlockSparsityPattern
and
@@ -787,7 +787,7 @@ All entries are signed with the names of the author.
New: There are now functions DoFTools
::map_dofs_to_support_points
and
+ class="member">map_dofs_to_support_points and
DoFTools
::map_support_points_to_dofs
that
@@ -826,7 +826,7 @@ All entries are signed with the names of the author.
(Roger Young 2001/04/12)
Fixed: the DoFRenumbering
::
(Oliver Rheinbach 2001/04/12)
Changed: A typedef FunctionMap
was
declared in at least four places previously (in classes
(WB 2001/04/09)
- Fixed: When using Neuman boundary functions in the
+ Fixed: When using Neuman boundary functions in the
KellyErrorEstimator
class, it was
assumed that the function object had Function
::
(WB 2001/04/09)
New: The various MatrixCreator
::
(WB 2001/04/08)
New: The following functions are extended to work on arbitrary mappings: @@ -903,7 +903,7 @@ All entries are signed with the names of the author.
All these functions now take a Mapping
object as additional argument.
-
+
For backward compatibility there exist second versions of
each of these functions that still don't have a Mapping
argument. These functions
@@ -941,7 +941,7 @@ All entries are signed with the names of the author.
(RH 2001/04/04)
New/Fixed: Now there exists a new Triangulation
::
(RH 2001/04/03)
Fixed: Missing
Removed: the
+
Removed: The function
+
New: The class
Changed: We now unconditionally include
+
New: The
- New: Output for
+ New: Output for
Tecplot has
been added. It can be used by choosing output format «tecplot».
- New: Output for
+ New: Output for
OpenDX has
been added. It can be used by choosing output format «dx» (not
yet for grid output). The data format is very basic now, but it
@@ -280,7 +280,7 @@ All entries are signed with the names of the author.
New: the
+
New:
+
Fixed: In 3d, the function ucd
is now added to the list of
supported output formats returned by
contained an assertion that failed erroneously for finite
elements that do not have degrees of freedom on vertices. This
is now fixed.
- ProblemBase
class,
- which has been deprecated since before the release of
+ which has been deprecated since before the release of
deal.II 3.0, has finally been removed. The
same applies for the classes
Assembler
,
@@ -1011,7 +1011,7 @@ All entries are signed with the names of the author.
the class VectorTools
are extended
to work on arbitrary mappings. All these functions now take a
Mapping
object as additional
- argument.
+ argument.
For backward compatibility there exist second versions of
each of these functions that still don't have a
-
function sometimes had problems when indicators vary over
several orders of magnitude, due to roundoff. This is now
- fixed.
+ fixed.
FiniteElement<dim>
::get_support_points
@@ -1096,7 +1096,7 @@ All entries are signed with the names of the author.
(RH 2001/03/14)
Boundary
has two new
functions get_intermediate_points_on_line
and
(RH 2001/03/14)
deal.II/include/grid/tria_accessor.templates.h
(which contains some inline functions for triangulation
- accessor classes) into
+ accessor classes) into
deal.II/include/grid/tria_accessor.h
to work
around a problem with gcc3.0 which does not place a copy of
these functions into the library. Previously we only included
@@ -1205,7 +1205,7 @@ All entries are signed with the names of the author.
(WB 2001/02/26)
DoFTools
class now has
a function count_dofs_per_component
that counts the number of degrees of freedom in each of the
diff --git a/doc/news/3.2.0-vs-3.3.0.h b/doc/news/3.2.0-vs-3.3.0.h
index b4099005ed..e412f1a6b7 100644
--- a/doc/news/3.2.0-vs-3.3.0.h
+++ b/doc/news/3.2.0-vs-3.3.0.h
@@ -27,7 +27,7 @@ All entries are signed with the names of the author.
@@ -51,7 +51,7 @@ All entries are signed with the names of the author.
SparseDirectMA27/47
classes
now provide access to Mutex locks for external
- synchronisation.
+ synchronisation.
(WB 2001/11/14)
(WB 2001/11/05)
DoFTools::extract_subdomain_dofs
selects
those degrees of freedom which are located on cells with a
diff --git a/doc/news/3.3.0-vs-3.3.1.h b/doc/news/3.3.0-vs-3.3.1.h
index ab54211aee..0461dd1657 100644
--- a/doc/news/3.3.0-vs-3.3.1.h
+++ b/doc/news/3.3.0-vs-3.3.1.h
@@ -23,20 +23,20 @@ All entries are signed with the names of the author.
-
DoFTools::make_hanging_node_constraints
+ class="member">DoFTools::make_hanging_node_constraints
+
(WB 2002/02/21)
Fixed: TriaAccessor<3,3>::measure
sometimes computed a negative value. This is now fixed.
-
+
(WB 2002/02/21)
+
New: The step-14 example program demonstrates duality based
error estimators and some more software design concepts.
(WB 2002/05/05)
+
New: In all previous versions, deal.II used
the ACE (Adaptive Communications Environment)
@@ -72,13 +72,13 @@ All entries are signed with the names of the author.
available on many systems. The relieves you from the need of
installing a huge library of which the most part is not used
anyway. However, if you use ACE for other reasons, then it is
- still supported. For installation instructions, see the
+ still supported. For installation instructions, see the
ReadMe file.
(WB 2002/04/30)
+
Changed: The Makefiles for the library are now truly parallel. To this end, the automatic generation of the files forward_declarations.h in the various directories had @@ -94,14 +94,14 @@ All entries are signed with the names of the author. (GK 2002/04/17)
-+
New: The step-13 example program tells you something about
software design things for finite element programs.
(WB 2002/04/16)
+
Changed: Due to problems with undeclared functions and general
compatibility concerns, -ansi
is now no more part
of the compile flags for gcc.
@@ -109,7 +109,7 @@ All entries are signed with the names of the author.
(WB 2002/04/16)
+
Fixed: Explicit specializations of member templates are now conforming to the C++ standard. While most compilers accepted the previous form, Sun's Forte compiler wants a strictly @@ -118,7 +118,7 @@ All entries are signed with the names of the author. (WB 2002/03/25)
-+
Fixed: For gcc versions that used ostrstream
instead of ostringstream
, it was necessary to append
@@ -129,23 +129,23 @@ All entries are signed with the names of the author.
(WB 2002/03/13)
+
Changed: The configure machinery has been revamped
significantly.
(WB 2002/03/08)
+
Added: The top-level Makefile now supports "optimized" as a
target that builds only optimized versions of the base
,
lac
, 1d
, 2d
, and 3d
- libraries.
+ libraries.
(BK 2002/02/19)
+
Changed: The build system was entirely revised. Object
files in debug mode now have the suffix .g.o
instead of .go
. All object files from the
@@ -163,17 +163,17 @@ All entries are signed with the names of the author.
+
New: The vector2d
row accessor
classes now have member functions begin
and end
which allow iterating over the elements of a row of such an
- object.
+ object.
(WB 2002/05/30)
+
New: The
+
Changed: The
+
Fixed: When forward declaring the
+
Fixed: The class
+
Improved: The Legendre
and
LagrangeEquidistant
classes now have
static member functions
-
Polynomial
and
LagrangeEquidistant
classes have lost
their default constructor, as that did not make much sense
@@ -194,7 +194,7 @@ All entries are signed with the names of the author.
(WB 2002/05/27)
Tensor
class, we now also forward declare
its partial specialization for a rank one tensor. Not doing so
@@ -203,7 +203,7 @@ All entries are signed with the names of the author.
(WB 2002/03/22)
TensorFunction
now uses local types value_type
and
gradient_type
as return values of
@@ -213,7 +213,7 @@ All entries are signed with the names of the author.
(WB 2002/03/20)
AssertThrow
macro now
uses __builtin_expect
if the
compiler supports this. This indicates to the compiler that we
@@ -234,7 +234,7 @@ All entries are signed with the names of the author.
(i.e. like to a two-dimensional C-style array).
(WB 2002/03/08)
-
Changed: The function MultithreadInfo
::
@@ -242,9 +242,9 @@ All entries are signed with the names of the author.
of CPUs when running on Silicon Graphics.
(BK 2002/02/19)
-
+
Changed: The quite logorrhoeic function name TensorProductPolynomials
::n_tensor_product_polynomials
was changed to
@@ -254,7 +254,7 @@ All entries are signed with the names of the author.
(GK 2002/02/11)
+
New: The class PolynomialSpace
implements the space of polynomials at most a certain degree in
arbitrary space dimensions.
@@ -262,7 +262,7 @@ All entries are signed with the names of the author.
(GK 2002/02/11)
+
New: The function DataOutBase
::
write_tecplot_binary
has been
added. This function will write Tecplot binary files if the
@@ -296,7 +296,7 @@ All entries are signed with the names of the author.
(GK 2002/05/24)
+
New: Function
+
New: Functions
+
New: The
+
New: The
+
Fixed: The
+
Fixed: In 3d, the function
+
Fixed:
+
New: Finite element family with complete polynomial spaces
for discontinuous Galerkin:
+
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,
@@ -50,7 +50,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/06)
+
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
@@ -60,7 +60,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
the string
Also note that boost is large -- much larger than the subset we
have imported --, so we only took what we needed.
@@ -68,7 +68,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/06)
+
Fixed: A longstanding bug in the documentation system has been fixed: if
a namespace was ended with
+
Changed: Classes and structures that are declared inside namespaces named
- Fixed: Some of the formulas in the step-14 tutorial were obviously
+
+ Fixed: Some of the formulas in the step-14 tutorial were obviously
scrambled a little. This is now fixed.
- Changed: The main Makefile has been changed to sequentialize building
+
+ Changed: The main Makefile has been changed to sequentialize building
the base, lac, and deal.II sublibraries. We changed this, since on some
systems (notably AIX), the latter libraries need to be linked against
the former ones, when creating shared libraries.
@@ -109,14 +109,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/24)
- New: Changes have been made to support compiling and using
+
+ New: Changes have been made to support compiling and using
deal.II on AIX 5 systems.
+
Removed: Thread support now relies solely on the use of POSIX
functions. The use of the
ACE
@@ -128,7 +128,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/11)
+
New: Some changes have been made to support Mac OS X 10.2. Shared
libraries are not supported on this architecture, but everything else
should work.
@@ -136,7 +136,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/12/18)
+
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
+
Changed: Previously, we just set the preprocessor variable
+
New: Object files are now named according to the local defaults
on the system we are running on. On Unix systems, this is
usually a
+
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.
@@ -189,7 +189,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/10/14)
+
Fixed: On CygWin, one header files has a
+
New: Since
+
New:
+
Removed: The forward declarations files have gone. We have never
propagated their use in the example programs, but these files have been
there in the base, lac, and grid include directories, and forward
@@ -254,15 +254,15 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/05)
+
New: There is now
a new report
- on assembling matrices available from the
+ on assembling matrices available from the
documentation
page. The main focus is assembling of matrices for
vector-valued problems, where shape functions are
vector-valued, and may have only one or more non-zero vector
- components.
+ components.
SparsityPattern::matrix_position
is the
inverse function for
-
SparsityPattern::copy_from
and SparseMatrix::copy_from
allow to copy a full
@@ -321,7 +321,7 @@ All entries are signed with the names of the author.
deal.II
-
diff --git a/doc/news/3.4.0-vs-4.0.0.h b/doc/news/3.4.0-vs-4.0.0.h
index ce73c93c87..d232304d95 100644
--- a/doc/news/3.4.0-vs-4.0.0.h
+++ b/doc/news/3.4.0-vs-4.0.0.h
@@ -28,7 +28,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
GeometryInfo
class now
provides two methods,
unit_cell_vertex
and
-
contained an assertion that failed erroneously for finite
elements that do not have degrees of freedom on vertices. This
is now fixed.
- GridOut::
write_dx
function is now implemented.
It allows to write the mesh (cells and faces) with some additional
@@ -341,7 +341,7 @@ All entries are signed with the names of the author.
(GK 2002/05/02)
IteratorState::IteratorState
enum is now called IteratorState::IteratorStates
. This works
@@ -352,27 +352,27 @@ All entries are signed with the names of the author.
(WB 2002/03/20)
DoFTools::make_hanging_node_constraints
+ class="member">DoFTools::make_hanging_node_constraints
+
(WB 2002/02/21)
TriaAccessor<3,3>::measure
sometimes computed a negative value. This is now fixed.
-
+
(WB 2002/02/21)
FE_DGP
-
+
(GK 2002/02/11)
General
-
_local
since you may still want to use
another version or installation of boost in your own programs.
}
instead of };
(note the semicolon), then the documentation tool assumed that the
@@ -82,7 +82,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/02)
internal
are now no longer shown in the class
index view of the documentation of each of the sublibraries. Since they
@@ -93,15 +93,15 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/02)
(Roy Stogner, WB 2003/01/30)
(WB 2003/01/24)
-Xc -ansi
that
@@ -152,13 +152,13 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/12/05)
DEAL_II_USE_MT
, when --with-multithreading
was
given as argument to ./configure
. Tests in the code
therefore looked like #ifdef DEAL_II_USE_MT
. This has been
changed so that the variable is always defined, but its value is now
- equal to 1
+ equal to 1
when multithreading was requested, and zero otherwise. The reason for
this is that you can now write if (DEAL_II_USE_MT && ...)
conditions, and need not interleave if-else clauses from regular code
@@ -171,7 +171,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/11/14)
.o
suffix, while on Windows it is
@@ -181,7 +181,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/11/11)
#define quad
quad_t
. This is annoying, since we have local variables and
member functions with the name quad
, and in fact it breaks
@@ -203,10 +203,10 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
set.
(Stephen Kolaroff, WB
- 2002/09/28)
+ 2002/09/28)
math.h
only defines the values of PI or E (as
M_PI
and M_E
) when certain defines are set (on
Linux, these are __USE_BSD
or __USE_XOPEN
),
@@ -219,7 +219,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/12)
base/config.h
now exports the
deal.II base directory through the
DEAL_II_PATH
preprocessor variable.
@@ -227,7 +227,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/09)
(WB 2002/06/17)
+
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 @@ -299,7 +299,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (WB 2002/06/10)
-+
New: The top-level makefile now how a target distclean. clean leaves the libraries now, removing everything that is not needed to use @@ -353,7 +353,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (WB 2003/02/13)
-+
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
@@ -362,7 +362,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/06)
+
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
@@ -371,7 +371,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/28)
+
Fixed: The PosixThreadManager
called
its wait
function in the
destructor. If this had been called before already, then the
@@ -384,7 +384,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(Michael Anderson, WB 2003/01/16)
+
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
@@ -395,7 +395,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/11)
+
Fixed: In multithreaded mode, when a new thread is started, the arguments to the function being called need to be copied from the stack of the starting thread to that of the new thread. In order to @@ -408,7 +408,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (Michael Anderson, WB 2003/01/11)
-+
New: There are now classes ThreadCondition
that implement thread condition variable operations through POSIX
functions (in multithreaded mode) or doing nothing (in singlethreaded
@@ -417,7 +417,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/11)
+
New: Newer versions of gcc have a very nice feature: you can set a verbose terminate handler, that not only aborts a program when an exception is thrown and not caught somewhere, but @@ -431,7 +431,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (WB 2002/12/19)
-+
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.
@@ -439,7 +439,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/11/29)
+
Changed: In POSIX mode, when the ThreadManager
class created a new thread through
pthread_create
, it only checked for the
@@ -453,7 +453,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/11/13)
+
Fixed: The write_text
and write_tex
functions of the TableHandler
class now check whether their
@@ -463,7 +463,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(RH 2002/11/11)
+
New: Added Hierarchical Polynomial (similar to Legendre class). Will eventually be used in a hierarchical FiniteElement class similar to FE_Q class. Included in Polynomials namespace. @@ -515,7 +515,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (RH 2002/09/24)
-+
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
@@ -531,7 +531,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(GK 2002/09/08)
+
Extended: Previously, the Threads::PosixThreadBarrier
class could not be used at all (they threw exceptions), if your system
@@ -545,7 +545,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/05)
+
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
@@ -558,14 +558,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/03)
+
New: There are now functions returning the transpose of Tensor
objects of rank 2.
(WB 2002/08/31)
+
New: Row accessors for the vector2d
class now have a member function size
that returns the size of the row,
@@ -574,7 +574,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/07/24)
+
Fixed: In EPS output, colors were set to invalid values if the values of the field that is used for coloring are all equal. This happens, for example, in the very first time step @@ -584,7 +584,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (WB 2002/07/24)
-+
Changed: To save disk space, color values in EPS output are written as grey scale with only one value instead of three RGB values if the color so represented is actually a grey scale. @@ -592,7 +592,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK (WB 2002/07/24)
-+
New: There are now operators to allow multiplication and
division of Tensor
objects by scalar
factors.
@@ -607,22 +607,22 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: Function +
New: Function
BlockSparseMatrix::print_formatted
- added, similar to the
+ added, similar to the
BlockVector::print_formatted
function.
(Brian Carnes 2003/06/02)
-
New: Functions SparseMatrix::operator *=
- and SparseMatrix::operator /=
as well as
+ and SparseMatrix::operator /=
as well as
BlockSparseMatrix::operator *=
- and BlockSparseMatrix::operator /=
+ and BlockSparseMatrix::operator /=
are added.
(Brian Carnes 2003/06/02)
-
Deprecated: The functions Vector::scale
and BlockVector::scale
are now deprecated
@@ -630,7 +630,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
operator/=
instead.
(WB 2003/05/31)
-
New: Vector
, BlockVector
and
@@ -638,7 +638,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
for scaling by a scalar.
(WB 2003/05/31)
-
New: PointerMatrix
now
has empty()
function, which returns true if the pointer is
@@ -699,7 +699,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/13)
+
New: The SolverGMRES
now accepts an
AdditionalData
parameter
use_default_residual
whose default is
@@ -714,7 +714,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(RH 2003/01/31)
+
New: FullMatrix
has a function copy_from
, copying from sparse matrices.
It uses iterators of the sparse matrix classes.
@@ -743,7 +743,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(Stephen Kolaroff 2002/11/27)
Changed: In multithread mode, the SparseMatrix
would spawn
@@ -757,9 +757,9 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/11/13)
- Fixed: In the 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.
@@ -776,7 +776,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
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
+ as you want. For more information, read the documentation of the
SparseDirectMA27
class.
(WB 2002/09/25)
@@ -814,7 +814,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
New: Classes SparsityPattern
and SparseMatrix
now have functions 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
without much need for parsing.
@@ -830,7 +830,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(GK 2002/08/13)
+
New: a way of using abstract base classes for matrices has
been implemented with PointerMatrixBase
and PointerMatrix
. Storing a matrix in
@@ -867,7 +867,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
to the child cell; child_to_cell_coordinates
that does
exactly the opposite; and is_inside_unit_cell
that tells whether a
+ class="member">is_inside_unit_cell that tells whether a
given point is inside the unit cell.
(WB 2003/05/01)
@@ -960,7 +960,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/02/21)
+
Changed: Some implementation details of the GridReordering
class have been moved to a
namespace internal
.
@@ -989,7 +989,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: Objects of type 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
@@ -1010,7 +1010,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(RH 2003/02/03)
+
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.
@@ -1018,7 +1018,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/28)
+
Changed: The FEValues::get_cell
and
FEValues::get_face
functions have
been removed, since they limited our ability to use this
@@ -1028,7 +1028,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/17)
+
New: The DoF accessor classes now have a function get_fe()
that returns a reference to the finite
element being used on this cell. The result is of course identical to
@@ -1039,22 +1039,22 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2003/01/10)
- New: Checked in new GridGenerator
+
+ New: Checked in new GridGenerator
member function half_hyper_ball
,
- derived from member hyper_ball
.
+ derived from member hyper_ball
.
The initial mesh contains four elements. This mesh will work with
the boundary class HalfHyperBallBoundary
.
(Brian Carnes 2002/12/16)
+
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.
+ derived from class FiniteElement
.
+ This element is analogous to FE_Q
, but
+ makes use of hierarchical shape functions, based on the
+ 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
@@ -1062,35 +1062,35 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
interpolation-projection operator, based on an hp-type interpolant.
The files for this element are
- deal.II/include/fe/fe_q_hierarchical.h
and
+ deal.II/include/fe/fe_q_hierarchical.h
and
deal.II/source/fe/fe_q_hierarchical.cc
.
(Brian Carnes 2002/12/13)
+
New: For finite element classes, the functions
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
+ composed element thus does not fill the array the
get_unit_support_points
function returns.
(WB 2002/11/23)
+
Fixed: Vectors could not be given as input and output vectors to the
SolutionTransfer
class at the same time, but
this was not checked. An assertion has now been added to ensure this
- requirement.
+ requirement.
(WB 2002/10/28)
+
Fixed: The DoFRenumbering::component_wise
function accepts a
parameter indicating the order in which the degrees of freedom
@@ -1101,7 +1101,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/10/17)
+
New: The
+
New: The
+
Fixed: The algorithm to generate neighbor information for patches from
cells in
+
Changed (internals): Previously, the finite element base class
initialized the restriction, prolongation, and face constraints matrices
to their correct size. Derived classes had to fill these classes, and
@@ -1166,16 +1166,16 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(GK 2002/09/19)
+
Fixed: Some of the various instances of the
+
Removed: The
+
Changed: The
+
New: The mapping classes now also know how to transform tensors of rank
2, not only vectors (tensors of rank 1) in a co- and contravariant way.
+
Fixed: the
+
Improved: FiniteElement::system_to_base_index
function now
exports the values of the
-
FiniteElement::element_multiplicity
function was
previously only available in the FESystem
@@ -1123,7 +1123,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/10/17)
DataOut::build_patches
was rather
inefficient, tripling the time for patch generation when support for
@@ -1135,7 +1135,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/10/10)
VectorTools::interpolate_boundary_values
functions
were not explicitly instantiated, leading to linker errors. This is now
- fixed.
+ fixed.
(WB 2002/09/19)
FiniteElement::component_to_system_index
function
and its counterpart for faces is gone. This data did not make much sense
@@ -1187,7 +1187,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/16)
FiniteElement::restriction_is_additive
function
used to take an argument that denoted the vector component of a finite
@@ -1201,14 +1201,14 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/09/16)
(WB 2002/09/03)
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.
@@ -1216,7 +1216,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/08/30)
VectorTools
::integrate_difference
can compute Lp
and W1,p norms for arbitrary p. The function
@@ -1298,7 +1298,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
the library.
(RH 2002/06/14)
-
Fixed: FE_Q::has_support_on_face
always returned
@@ -1351,7 +1351,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(RH 2002/06/10)
+
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
@@ -1364,7 +1364,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
(WB 2002/06/08)
+
New: For encapsulated postscript output of 2d grids, it is now
possible to tell the GridOut
class to
write the cell numbers into each cell, as well as the numbers
diff --git a/doc/news/4.0.0-vs-5.0.0.h b/doc/news/4.0.0-vs-5.0.0.h
index 303c117ae7..337b9ecabf 100644
--- a/doc/news/4.0.0-vs-5.0.0.h
+++ b/doc/news/4.0.0-vs-5.0.0.h
@@ -15,7 +15,7 @@
/**
* @page changes_between_4_0_and_5_0 Changes between Version 4.0 and 5.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
@@ -49,7 +49,7 @@ inconvenience this causes.
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.
-
+
(WB 2004/05/10)
vector=0
and matrix=0
. To
reset the elements of a table over arbitrary objects, use
Table<T>::reset_values()
.
- Removed: The SparseLUDecomposition::reinit
and SparseMIC::reinit
functions without
argument had been deprecated before, and have now been removed.
-
+
(WB 2004/05/10)
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
.
Moved and changed: The header file
- include/numerics/dof_renumbering.h has been moved to the
+ 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
the reference documentation for details.
@@ -177,14 +177,14 @@ 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
automatically in ./configure
, or
by passing a value to the switch --with-metis
to configure
the path of a METIS installation. For more information see the README
- file.
+ file.
(WB 2004/03/08)
New: deal.II now comes with a complete set of
wrappers classes for PETSc vectors, matrices, linear solvers and
+ target="_top">PETSc vectors, matrices, linear solvers and
preconditioners. Many of the algorithms in deal.II have also been
updated to make use of these wrappers. All of this is only enabled if a
PETSc installation is detected. This either happens automatically in
@@ -225,7 +225,7 @@ inconvenience this causes.
some compiler/platforms requires boost files in addition to
those included in the contrib directory please report
the missing boost files to the deal.II mailing list.
-
+
(RH 2004/02/16)
step-9
had the computation of the value of the
solution in the mid-point of the neighbor cell wrong. This is now
fixed. Consequently, the resulting mesh also looks much nicer now (much
- smoother).
-
Augmented: The GeometryInfo::child_cell_on_face
+ class="member">GeometryInfo::child_cell_on_face
results in a result that might not be what you expect in 3d in some
cases. A warning has been added to the documentation, as well as a
reference to the function to call instead.
-
+
(WB 2003/10/17)
Fixed: On AIX systems, the xlf Fortran77 compiler wasn't recognized +
Fixed: On AIX systems, the xlf Fortran77 compiler wasn't recognized
due to the fact that when called with -v it generates many pages
of output, later leading to a shell error. This is now fixed.
@@ -340,7 +340,7 @@ inconvenience this causes.
+
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,
@@ -351,7 +351,7 @@ inconvenience this causes.
(RH 2004/03/11)
+
New: The classes PolynomialSpace
and
TensorProductPolynomials
now have
new set_numbering
functions which
@@ -387,7 +387,7 @@ inconvenience this causes.
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
+ However, on machines where long double is the same as double, it
never reached the requested accuracy, in effect leading to an infinite loop.
This is now fixed.
@@ -521,14 +521,14 @@ inconvenience this causes.
(WB 2004/01/26)
Improved: Initialization routines of class SparseMatrix
have an additional parameter
controlling the storage of diagonal entries.
(GK 2003/11/18)
New: +
New:
SolverFGMRES
implements the flexible
GMRES method with varying preconditioner from the right. It is
also accessible in SolverSelector
by choosing fgmres.
@@ -597,14 +597,14 @@ inconvenience this causes.
(Luca Heltai 2004/04/21)
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
additional parameter that lets it only compute error indicators for a
@@ -652,7 +652,7 @@ inconvenience this causes.
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
,
+ 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.
@@ -702,7 +702,7 @@ inconvenience this causes.
Improved: FiniteElementData
has a function
tensor_degree()
, returning the degree of the
polynomial space suitable for choosing a tensor product quadrature
- formula.
+ formula.
(GK 2003/11/28)
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
- which generates a rectangle with given corner points and possibly
+ 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
with square cells.
-
+
(Joerg Weimar 2003/09/09)
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.
-
Improved: GridOut
has a an improved
- functionality for write_eps
+ functionality for write_eps
to color the grid according to the refinement level.
- A corresponding option is included in
+ A corresponding option is included in
GridOutFlags::Eps<2>
.
-
+
(Joerg Weimar 2003/09/09)
FEFaceValuesBase
has a new
function orientation
accessing a unique
and consistent orientation for each face.
- +
Changed: Embedding and restriction matrices for intergrid transfer are now computed in the constructor of most elements, rather than taken from precomputed and tabulated values. This removes restrictions on which @@ -843,7 +843,7 @@ inconvenience this causes. (WB 2003/06/09)
-+
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
@@ -854,14 +854,14 @@ inconvenience this causes.
(WB 2003/06/09)
+
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.
(WB 2003/06/09)
diff --git a/doc/news/5.0.0-vs-5.1.0.h b/doc/news/5.0.0-vs-5.1.0.h
index beeae1cb3a..c84dae49ca 100644
--- a/doc/news/5.0.0-vs-5.1.0.h
+++ b/doc/news/5.0.0-vs-5.1.0.h
@@ -58,7 +58,7 @@ inconvenience this causes.
and leads to very hard to find errors. Therefore, all constructors and
reinit functions of the parallel sparse matrix classes now take an
additional argument indicating the partitioning of columns of the matrix.
-
+
(WB 2004/06/02)
- New: Support of shared libraries under Cygwin / Windows systems. Shared
+ New: Support of shared libraries under Cygwin / Windows systems. Shared
libraries are used as default. To use, make sure the library path is included
in your PATH
environment variable.
@@ -93,7 +93,7 @@ inconvenience this causes.
- New: Configuration now detects the Intel Fortran compiler and can set
+ New: Configuration now detects the Intel Fortran compiler and can set
compilation flags accordingly.
(WB 2004/11/04)
@@ -117,7 +117,7 @@ inconvenience this causes.
- New: configuration option --with-umfpack for using the
+ New: configuration option --with-umfpack for using the
UMFPack version and enabling the class SparseDirectUMFPACK
, both included by
Wolfgang.
@@ -136,7 +136,7 @@ inconvenience this causes.
Fixed: None of the formulas in the step-8 tutorial program web
page were visible. This is now fixed.
-
+
(WB 2004/06/29)
+
New: The MultithreadInfo
class now also detects multiple
processors on Mac OS X.
-
+
(Helmut Müller 2004/11/29)
+
New: The
TableHandler::write_tex
now accepts the additional boolean
argument with_header
which is set to
- true by default and tells the function whether to add the latex
+ 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.
- In addition to this, there are two new members in the above class:
+ \\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
- add a caption and a label to the tex generated table.
-
+ add a caption and a label to the tex generated table.
+
(Luca Heltai 2004/10/29)
N
-dimensional array and might replace the
N-times-nested-use of the std::vector
class.
+ class="class">std::vector class.
New: Class TableIndices
now has
operators that check for equality and inequality of objects.
-
+
(WB 2004/07/28)
New: A class PointerComparison
for comparing
pointers that may or may not be of the same type.
-
+
(WB 2004/06/22)
ok
is consequently gone as well.
-
New: A class PreconditionLU
which
provides a wrapper to the complete LU decomposition
- preconditioner of PETSc. Furthermore a class
+ preconditioner of PETSc. Furthermore a class
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
simple direct solver, which could be used for small to medium
sized problems on a single processor machine.
-
+
(Oliver Kayser-Herold 2004/07/27)
Improved: VectorTools::point_difference
used to use an algorithm to find the cell the given point is in that
@@ -271,7 +271,7 @@ inconvenience this causes.
to use
GridTools::find_active_cell_around_point
which is only logarithmic in its complexity.
-
+
(WB 2004/07/07)
operator <
to compare iterators.
-
Improved: The SparseDirectMA27
class can now
handle float as well as double input matrices and vectors.
-
+
(WB 2004/06/23)
local_range
,
in_local_range
, and local_size
.
- get_mpi_communicator
that returns the MPI
communicator object these objects operate on.
- get_mpi_communicator
function.
- SolutionTransfer
class
actually does. This is now properly documented.
- 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.
- FEValuesBase::get_cell
function returns the current cell, i.e. the latest cell the
FEValues
object was reinited with.
- MatrixTools
class.
- New:
The step-19 tutorial demonstrates handling of parameters from a
parameter file, as well as some simple techniques for merging output
- from parallel computations.
+ from parallel computations.
(WB 2005/09/09)
-Xlinker
+ debugging now... In this case remove the -Xlinker
--allow-multiple-definition
flag from Make.global_options.
(Ralf B. Schulz, 2005/07/13)
@@ -236,7 +236,7 @@ inconvenience this causes.
-
Fixed: When compiling shared libraries on CygWin systems, warnings
concerning the -fPIC
option were issued by the compiler.
- This is now fixed.
+ This is now fixed.
Also, configure now issues a message at the end that you should include
the DLL-path in your .bash_profile
file on these systems.
@@ -254,7 +254,7 @@ inconvenience this causes.
systems. A new preprocessor variable, DEAL_II_BROKEN_SOCKETS
has been added to base/config.h
which is defined on
affected systems.
-
+
(Ralf B. Schulz, WB, 2005/03/02)
@@ -262,7 +262,7 @@ inconvenience this causes.
Fixed: The step-16 example program wasn't listed in the
navigation bar of the tutorial section, although it was in the
table of contents. This is fixed now.
-
+
(WB, 2005/02/09)
Removed: The write_multigrid
flag in DataOutBase::DXFlags
+ class="member">DataOutBase::DXFlags
has been removed, since it wasn't used anywhere.
(WB, 2005/07/14)
@@ -323,7 +323,7 @@ inconvenience this causes.
(Ralf B. Schulz, 2005/07/13)
Improved: The QProjector
now has
functions project_to_face
and double_contract
contracts two tensors of
rank 4 and 2 into a tensor of rank 2, by contracting over two
indices at the same time.
-
+
(WB, 2005/03/29)
New: There is a new class SymmetricTensor
that provides storage and operations for symmetric tensors.
-
+
(WB, 2005/03/28)
SmartPointer
constructors throughout the
library.
-
New: Class FunctionParser
. Wrapper
- class for the fparser library (see
+ class for the fparser library (see
http://warp.povusers.org/FunctionParser/).
-
+
(Luca Heltai, 2005/03/07).
Fixed: The class MultipleParameterLoop::UserClass
had only
+ class="class">MultipleParameterLoop::UserClass 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. The same holds with respect to the class
DataOutInterface
.
-
+
(WB, 2005/02/20)
PetscWrappers::VectorBase::set
allows to set
several vector elements at once.
-
Fixed: The PETSc matrix iterators had trouble when some rows of a
matrix were empty. This has now been mostly fixed.
-
+
(WB, 2005/05/02)
ProductSparseMatrix
implements the product of two rectangular sparse matrices with
the same value_type
-
New: The PreconditionRichardson
implements a Richardson preconditioner.
-
+
(GK, 2005/03/10)
DataOut
class already does for a long time.
- DataOutStack
class can now also be
used to stack two-dimensional time or parameter dependent data into a 3d
output.
- - +
Using this function, constraint matrices can be computed in
a general way.
-
+
(GK, 2005/07/14)
New: Added function FiniteElementBase::component_to_system_index
@@ -814,7 +814,7 @@ inconvenience this causes.
also for the case of non-standard oriented faces in 3d. This
avoids several awful pieces of code including questioning
face_orientation and using child_switch_tables.
-
+
(RH, 2005/06/16)
FE_Q
object. Now this function can
also be called by the FE_Q
constructor which avoids code duplication.
-
New: The method create_mass_matrix
- in class MatrixCreator
can now handle
+ 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
@@ -839,7 +839,7 @@ inconvenience this causes.
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.
-
+
(Oliver Kayser-Herold, 2005/06/03)
build_patches
.
- Mapping::transform_*
functions accept VectorSlice
instead
of Vector
, thus allowing more flexibility.
-
New: The MatrixTools::apply_boundary_values
function now also works for PETSc sequential and parallel matrices.
-
+
(WB, 2005/05/05)
PathSearch
. Furthermore, a library of input
meshes has been started in lib/meshes
.
- GeometryInfo
::line_to_cell_vertices
function maps line
vertex numbers to cell vertex numbers.
- GeometryInfo
::face_to_cell_lines
function maps face
line numbers to cell line numbers.
- GeometryInfo
::face_to_cell_vertices
function maps face
vertex numbers to cell vertex numbers.
- GridOut
for refined grids.
-
Fixed: Several wrong assertions in the Raviart-Thomas finite element
class have been fixed, that were triggered when integrating face terms.
-
- (Oliver Kayser-Herold, 2005/01/24;
+
+ (Oliver Kayser-Herold, 2005/01/24;
WB, 2005/01/31)
dealii::
namespace access.
- CellData
structure that can be used to describe cells
- when building a triangulation. This has now been rectified.
- DoFTools::map_dof_to_boundary_indices
has been
changed. Fortunately, this is a rarely used function so that the effect
should be limited to only a few programs.
- InterGridMap
class has been changed. Code
like e.g. InterGridMap<DoFHandler,2>
must be
replaced by InterGridMap<DoFHandler<2> >
.
- ::DoFHandler
or
hp::DoFHandler
.
- std::ostringstream
class in general,
has been removed.
- Line
and Quad
out of the global
namespace.
- DoFRenumbering::component_wise(static_cast<DoFHandler<dim>&>(mg_dof_handler))
)
- Triangulation::create_triangulation
- function.
- New: The step-27 tutorial program has been added. It solves a Laplace
- equation with hp finite elements
+ equation with hp finite elements
and shows how to set finite element degrees, assemble matrices on
cells with varying polynomial degrees, and how to compute a simple
criterion for estimating the local Sobolev smoothness of a function.
@@ -243,12 +243,12 @@ inconvenience this causes.
been extended by new flags face_flip and face_rotation,
denoting a face which is rotated against the 'standard face' by 180 and 90
degrees, respectively. Furthermore, there is a new flag
- line_orientation with obvious meaning.
+ line_orientation with obvious meaning.
These flags have to be respected during creation and refinement of a
triangulation, when projecting quadrature points to faces or when the dof
indices on a cell are extracted. Furthermore, asking for vertices and
lines of cells is in some cases a bit more complicated. The same applies,
- for example,
+ for example,
to the extraction of the information, which child of a neighbor is behind
a given subface. However, this information is supplied by various
functions in GeometryInfo
. As a rule-of-thumb:
@@ -298,7 +298,7 @@ inconvenience this causes.
libraries that would contain illegal instructions. This is now fixed.
(WB 2006/08/09)
-
Changed: The default number of subdivisions in the build_patches
functions of the DataOut classes is
now part of the parameters read by parse_parameters
. This default value is used
@@ -312,7 +312,7 @@ inconvenience this causes.
library instead of the contributed.
(GK 2006/03/23)
-
New: The step-20 tutorial program was added. It shows how to use
Raviart-Thomas elements to solve a mixed formulation of the Laplace
@@ -367,7 +367,7 @@ inconvenience this causes.
the API manual (and the other way round) and leads to a
generally much nicer output. In particular, formulas embedded
in the documentation of the programs are now properly displayed.
-
+
(WB 2006/01/16)
PETSC_ARCH
environment variables but do not wish
deal.II to be configured for PETSc use, you
should specify --with-petsc=no
as a flag during
- configuration.
-
Fixed: The Tecplot library (tecio.a) was
detected but not added to LIBS. This is now fixed.
-
+
(RH 2005/09/23)
New: There is a new class:
Functions::FEFieldFunction
which is a Function
- interface to a finite element solution.
-
+ interface to a finite element solution.
+
(Luca Heltai 2007/08/29)
-
+
Improved: FunctionDerivative
is now
derived from AutoDerivativeFunction
and implements
gradients as well, giving you automatic second derivatives of a function.
@@ -468,7 +468,7 @@ inconvenience this causes.
n
is a constant known at compile time. It allows to
calculate powers efficiently at compile time, most often things like a
number to the power dim
.
-
+
(WB 2007/06/23)
New: The new Functions::Monomial
class implements
monomials as a function object.
-
+
(WB 2006/12/15)
Fixed: If no substring is found with a width smaller than the given
threshold, the Utilities::break_text_into_lines
function now
returns the smallest possible substring (larger than the threshold).
-
+
(Tobias Leicht 2006/12/13)
- void f() + void f() { Triangulation tria; DoFHandler *dh = new DoFHandler(tria); @@ -601,7 +601,7 @@ inconvenience this causes. distance of a given point to the unit cell, and
computed wrong values for the right + hand sides. This has been fixed.project_to_unit_cell
returning the projection of a point onto the unit cell. Also, a new membervertex_to_face
allow - to determine to which faces of a cell a vertex belongs. + to determine to which faces of a cell a vertex belongs.
(Ralf B. Schulz 2006/05/10) @@ -648,7 +648,7 @@ inconvenience this causes. (GK 2006/03/08) -Fixed: Writing a denormal "NaN" through
LogStream
objects such as +Fixed: Writing a denormal "NaN" through
LogStream
objects such asdeallog
erroneously printed zero, rather than "nan". This is now fixed.
@@ -721,7 +721,7 @@ inconvenience this causes.New: There are new functions -
@@ -756,7 +756,7 @@ inconvenience this causes.Utilities::match_at_string_start
and +Utilities::match_at_string_start
andUtilities::get_integer_at_position
.
(WB 2005/12/19) @@ -747,7 +747,7 @@ inconvenience this causes. Fixed: The tecplot_binaryOutputFormat
has been added toDataOutBase::get_output_format_names
. Now an exception will be raised ifwrite_tecplot_binary
is invoked without specifying the filename through theDataOutBase::TecplotFlags
interface. -
+
(RH 2005/09/23)Utilities::System
namespace. In case of a code not running in parallel, they simply return 1 and 0, respectively. -
+
(RH 2005/09/20) @@ -803,13 +803,13 @@ inconvenience this causes. (WB 2007/02/09) -Improved: A simple
print_formatted
+Improved: A simple
-print_formatted
function has been added toSparseMatrixEZ
.
(Moritz Allmaras 2007/02/08)Fixed: The
SparseDirectMA27
+Fixed: The
-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 @@ -818,7 +818,7 @@ inconvenience this causes. (WB 2006/12/21)Fixed: The
FullMatrix::invert
+Fixed: The
+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.
@@ -853,7 +853,7 @@ inconvenience this causes. now estimate the condition number of the linear system usingTridiagonalMatrix
and LAPACK.
(GK 2006/09/06) -New: the class
TridiagonalMatrix
has been introduced together with its basic methods, including an @@ -863,8 +863,8 @@ inconvenience this causes.Improved: PETSc 2.3.1 (build 16) is now supported by the - linear preconditioner classes. The new PETSc functions -
@@ -874,43 +874,43 @@ inconvenience this causes. the transpose of the matrix it points to.PCFactorSetXXX
are used.
+ linear preconditioner classes. The new PETSc functions +PCFactorSetXXX
are used.
(Florian Prill, 2006/08/04)
(GK 2006/07/07) - +New: There is now a function
- +FullMatrix::trace
that does what its name suggests it does.
(WB 2006/06/16)Improved:
- +PointerMatrixAux
now has a default constructor and a function for setting theVectorMemory
object.
(GK 2006/06/14)Fixed:
- +FullMatrix::print
would yield a link error when used withstd::ofstream
since an explicit instantiation was missing. The function has now been moved to the header file and made inline so that it is always visible, whatever the type of the output stream is. -
+
(WB 2006/06/07)Improved: The
SparseDirectUMFPACK
solver can now also be used with sparse matrices with elements of type float, as well as with block matrices with types float and double. -
+
(WB 2006/04/25)New: The function
- +BlockSparsityPattern::row_length
adds up the row lengths of the individual blocks of a block matrix for a given row. -
+
(WB 2006/04/25)New: There is a new class
- +IdentityMatrix
that represents an efficient version of the matrix with ones on the diagonal and zeros everywhere else. The main usefulness of this matrix lies @@ -918,10 +918,10 @@ inconvenience this causes. assignment operators and copy constructors that allow to conveniently fill a (sparse, full) matrix with the identity matrix. -
+
(WB 2006/04/24)New: There are now assignment operators from
+BlockVector
toVector
and back.
(WB 2006/03/30) @@ -942,7 +942,7 @@ inconvenience this causes. the linear solver fails.
(Stephan Kramer, WB 2006/03/15) -Changed: There are new
+FullMatrix
::equ
functions which assign this @@ -951,7 +951,7 @@ inconvenience this causes. function for three vectors.
(RH 2006/02/21) -Fixed: The
+SolverMinRes
class did not work @@ -959,27 +959,27 @@ inconvenience this causes. This is now fixed.
(Luca Heltai 2006/02/19) -Changed: There are now new
+FullMatrix
::add
functions which add two and three scaled matrices.
(RH 2006/02/16) -Changed: The matrix classes
+ -FullMatrix
,SparseMatrix
,SparseMatrixEZ
andBlockMatrixBase
now have anadd
function analogous to theadd
of vector classes. The oldadd_scaled
functions are now deprecated.
(RH 2006/02/16) -+
Improved:
+BlockMatrixArray
::enter_aux
allows using matrices without adding vector multiplication by usingPointerMatrixAux
.
(GK 2006/02/02) -New: The class
@@ -1014,7 +1014,7 @@ inconvenience this causes. specifically use a different memory allocation class, have been changed to not specify anything at all, and thus fall back to the default. -PointerMatrixAux
was @@ -994,10 +994,10 @@ inconvenience this causes. Improved: TheFilteredMatrix
class was able to filter only theSparseMatrix
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 + 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 the usual matrix vector operations. -
+
(Luca Heltai 2006/01/09)
+
(WB 2005/11/23) @@ -1024,7 +1024,7 @@ inconvenience this causes. (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 compiler complained about an ambiguity. This is now fixed. -
+
(WB 2005/10/17) @@ -1033,7 +1033,7 @@ inconvenience this causes. also theTvmult
method. This feature allows the straightforward use ofSparseILU
as a multigrid smoother within the framework. -
+
(Oliver Kayser-Herold 2005/09/15) @@ -1047,11 +1047,11 @@ inconvenience this causes.New: There is a new class:
Functions::ParsedFunction
which is friendly wrapper to theFunctionParser
class. -
+
(Luca Heltai 2007/08/29) - +Fixed: the function -
DataOut::build_patches
+DataOut::build_patches
had a quadratic algorithm when generatic cell-data (as opposed to DoF data). This algorithm became a bottleneck when generating output on meshes with large number of cells. This is @@ -1061,14 +1061,14 @@ inconvenience this causes.New: the function -
DoFTools::get_active_fe_indices
+DoFTools::get_active_fe_indices
extracts for each cell the active finite element index used on it.
(WB 2007/08/07)Extended: the function -
Triangulation::copy_triangulation
+Triangulation::copy_triangulation
copies all members of a triangulation except for the list ofRefinementListener
s. In most cases this is exactly the intended behavior. However, if a RefinementListener should be copied to @@ -1080,7 +1080,7 @@ inconvenience this causes.New: the function -
DoFTools::make_sparsity_pattern
+DoFTools::make_sparsity_pattern
now takes an optional constraint matrix argument that can be used to avoid the subsequent call to condense the sparsity pattern. In effect, the sparsity pattern is generated condensed right away. For problems in @@ -1091,7 +1091,7 @@ inconvenience this causes.New: the new function -
ConstraintMatrix::add_entries_local_to_global
+ConstraintMatrix::add_entries_local_to_global
can be used to add entries to a matrix where entries that will appear if the current entry corresponds to a constrained degree of freedom are also added. @@ -1100,7 +1100,7 @@ inconvenience this causes.Fixed: the function -
GridTools::find_cells_adjacent_to_vertex
+GridTools::find_cells_adjacent_to_vertex
was not detecting properly the coarse cells adjacent to refined cells.
@@ -1110,9 +1110,9 @@ inconvenience this causes.Fixed: the two tools
@@ -1180,9 +1180,9 @@ inconvenience this causes. (WB 2007/02/20) -DoFTools::count_dofs_per_component
andDoFTools::count_dofs_per_block
where changing the - size of the destination vector. Consistently with (most of) the - rest of the library, now the vectors are expected to be the - right size before calling these functions. + size of the destination vector. Consistently with (most of) the + rest of the library, now the vectors are expected to be the + right size before calling these functions.
(Luca Heltai 2007/05/15)New: Added function
GridGenerator
::hyper_cube_with_cylindrical_hole
that produces +New: Added function
@@ -1192,7 +1192,7 @@ inconvenience this causes. be properly visualized. The boundary indicator was added to the material flag of the faces (which is ignored when reading back the mesh) in order for the Gmsh reader to be able to display the boundary - indicator in a proper way. + indicator in a proper way.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. + along the z-direction between 0 and L.
(Luca Heltai 2007/02/15)
(Luca Heltai 2007/02/15) @@ -1214,8 +1214,8 @@ inconvenience this causes.Fixed:
MatrixCreator
::create_mass_matrix
and- create_laplace_matrix
computed wrong values for the right - hand sides. This has been fixed. + create_laplace_matrix
(Moritz Allmaras 2007/02/08) @@ -1311,13 +1311,13 @@ inconvenience this causes.
New: There are now two new functions GridGenerator
::subdivided_hyper_rectangle
that produces
a non-uniformly subdivided rectangle, ideally suited for graded
- meshes. One of these functions is able to create meshes with holes.
+ meshes. One of these functions is able to create meshes with holes.
(Yaqi Wang 2006/11/15, 2006/12/29)
Fixed: Corrected clone
method
- of FE_DGQ
class for non-equidistant
+
Fixed: Corrected clone
method
+ of FE_DGQ
class for non-equidistant
support points.
(Florian Prill 2006/10/31)
@@ -1335,7 +1335,7 @@ inconvenience this causes.
New: There is a new functions GridTools
::create_union_triangulation
that generates a triangulation that contains the respectively
finest cells of two input triangulations.
-
+
(WB 2006/10/23)
ConstraintMatrix::close()
function is called. The only
thing that is not allowed are cycles in such constraints.
-
New: There are new functions GridTools::minimal_cell_diameter
and GridTools::maximal_cell_diameter
, with obvious
- functionality.
-
+ functionality.
+
(WB 2006/09/06)
Extended: The VectorTools::project
functions
are now also implemented for 1d.
-
+
(WB 2006/08/08)
DerivativeApproximation
::derivative_norm
function can be used. Note, that
for second order derivatives, this returns the largest eigenvalue
instead of the Frobenius norm, which is returned by the Tensor<rank_,dim>
::norm
function.
- dofs_per_quad
, ..., depending on the explicitly
specified function template argument. This is often useful for
template trickery.
- VectorTools
::point_value
and VectorTools
::point_difference
using the old interface
without boundary mapping were replaced by wrapper functions
calling the new versions.
-
Improved: The functions VectorTools
::point_value
and VectorTools
::point_difference
now can also use arbitrary
mappings, using the new GridTools
::find_active_cell_around_point
algorithm.
-
+
(Ralf B. Schulz, 2006/05/11)
DoFCellAccessor
class that provides
access to cells (i.e. lines in 1d, quads in 2d, and hexes in
3d) for which this operation is actually useful.
- Fixed: second derivatives where not computed correctly in FEFaceValuesBase
, i.e. when evaluating
second derivatives on faces of cells. This is now fixed. Using
second derivatives evaluated at quadrature points within a cell
@@ -1519,7 +1519,7 @@ inconvenience this causes.
Triangulation::clear_user_flags_quad
, and
Triangulation::clear_user_flags_hex
can be used to
selectively clear only some of the user flags as needed.
-
+
(WB 2006/04/25)
VectorTools::project
functions can now
also be used for vector arguments of type other than
Vector<double>
.
- GridTools::have_same_coarse_mesh
figures
out whether two triangulations, two DoFHandlers, etc, are built on the
same coarse mesh.
- FiniteElement
::face_to_equivalent_cell_index
that can
convert a face index of a degree of freedom into a
corresponding cell index.
-
New: There are now functions VectorTools
::point_value
that evaluate the value of a
finite element function at a given point inside the domain.
-
+
(WB 2006/03/06)
Triangulation
, PersistentTriangulation
, DoFHandler
, hp::DoFHandler
and MGDoFHandler
classes now all have a dimension
variable which allows to ask
the template argument dim by
SomeClass::dimension
.
-
Fixed: When used, the copy constructor of MappingQ
would lead to memory
corruption. This is now fixed.
-
+
(RH 2006/02/23)
- New: There is now a GridOut
::write_gmsh
function to write in the gmsh
- format. It has the same features of the write_ucd one.
-
+ New: There is now a GridOut
::write_gmsh
function to write in the gmsh
+ format. It has the same features of the write_ucd one.
+
(Luca Heltai 2006/02/17)
operator[]
function. Similarly, the FECollection
::n_finite_elements
, QCollection
::n_quadratures
and MappingCollection
::n_mappings
functions are now renamed to
the standard size()
function.
-
- Improved: GridGenerator
::half_hyper_ball
now is implemented also
- in three dimensions, and the boundary now is colored with 0 and one
+ Improved: GridGenerator
::half_hyper_ball
now is implemented also
+ in three dimensions, and the boundary now is colored with 0 and one
respectively on the curved and plane.
-
+
(Luca Heltai 2006/02/07)
MGDoFHandler
::distribute_dofs
and renumber
functions could not handle
coarsened grids (unused vertices, faces and cells). This is now
fixed.
- Mapping
class and derived classes now have
functions clone()
that return a new object of the same
(derived) type.
- KellyErrorEstimator
class now also allows to
select the cells on which it is supposed to work by giving a material
ID, instead of only a subdomain ID.
- TriaAccessor::ExcCellHasNoChildren
exception will be raised if the TriaObjectAccessor::child_index
function
is invoked for cells without children.
-
New: There is now a new Triangulation::get_boundary_indicators
function.
-
+
(RH 2005/09/30)
GridTools::delete_unused_vertices
function. Previously a private function in GridIn
it has now been moved to and made
public in GridTools
.
- New: When computing errors using
VectorTools::integrate_difference in codimension one problems, if
you specified a norm that requires the computation of the gradients,
@@ -452,7 +452,7 @@ independent of the dimension.
(Luca Heltai, 2010/12/05)
New: The VectorTools::interpolate_boundary_values function can now also be used to interpolate boundary values on meshes embedded in a higher dimensional space. diff --git a/doc/news/8.2.1-vs-8.3.0.h b/doc/news/8.2.1-vs-8.3.0.h index a8ca05497a..4421af5157 100644 --- a/doc/news/8.2.1-vs-8.3.0.h +++ b/doc/news/8.2.1-vs-8.3.0.h @@ -554,8 +554,8 @@ inconvenience this causes.
/path/to/install/dir
" in the
command above needs to be replaced by the path to the directory which deal.II should be installed into. This can be a directory in your home directory (e.g., ~/bin/deal.II
) or a directory such as /usr/local
if you have root privileges.
- Another option is to use something like `pwd`/../installed/
(note the backticks).
+ Another option is to use something like `pwd`/../installed/
(note the backticks).
make test
automatically runs in parallel and no -jN
flag should be supplied to it.
@@ -453,7 +453,7 @@
while providing a multitude of linear solvers and preconditioners
and extension to other linear operators with minimal changes required in the code.
To enable Ginkgo, pass -DGINKGO_DIR=/path/to/ginkgo
to CMake when
- configuring deal.II. For more detailed instructions, one can refer to
+ configuring deal.II. For more detailed instructions, one can refer to
this page.
@@ -622,7 +622,7 @@
-DSUNDIALS_DIR=/path/to/sundials
to the deal.II CMake call.
-
+
PETScWrappers::MPI::Vector
and
every processor in the MPI network only stores
a part of the matrix or vector. More specifically, each processor will
only store those rows of the matrix that correspond to a degree of
-freedom it "owns". For vectors, they either store only elements that
+freedom it "owns". For vectors, they either store only elements that
correspond to degrees of freedom the processor owns (this is what is
necessary for the right hand side), or also some additional elements
that make sure that every processor has access the solution components
-that live on the cells the processor owns (so-called
+that live on the cells the processor owns (so-called
@ref GlossLocallyActiveDof "locally active DoFs") or also on neighboring cells
(so-called @ref GlossLocallyRelevantDof "locally relevant DoFs").
@@ -55,7 +55,7 @@ single machine if PETSc was configured without MPI.
Developing software to run in %parallel via MPI requires a bit of a change in
mindset because one typically has to split up all data structures so that
every processor only stores a piece of the entire problem. As a consequence,
-you can't typically access all components of a solution vector on each
+you can't typically access all components of a solution vector on each
processor -- each processor may simply not have enough memory to hold the
entire solution vector. Because data is split up or "distributed" across
processors, we call the programming model used by MPI "distributed memory
@@ -63,15 +63,15 @@ computing" (as opposed to "shared memory computing", which would mean
that multiple processors can all access all data within one memory
space, for example whenever multiple cores in a single machine work
on a common task). Some of the fundamentals of distributed memory
-computing are discussed in the
+computing are discussed in the
@ref distributed "Parallel computing with multiple processors using distributed memory"
documentation module, which is itself a sub-module of the
-@ref Parallel "Parallel computing" module.
+@ref Parallel "Parallel computing" module.
In general, to be truly able to scale to large numbers of processors, one
needs to split between the available processors every data structure
whose size scales with the size of the overall problem. (For a definition
-of what it means for a program to "scale", see
+of what it means for a program to "scale", see
@ref GlossParallelScaling "this glossary entry".) This includes, for
example, the triangulation, the matrix, and all global vectors (solution, right
hand side). If one doesn't split all of these objects, one of those will be
@@ -134,7 +134,7 @@ wait for this return message but the original receiver was distracted
and not paying attention, then you're out of luck: you'll simply have to
wait until your requested over there will be worked on. In some cases,
bugs will lead the original receiver to never check your mail, and in that
-case you will wait forever -- this is called a deadlock.
+case you will wait forever -- this is called a deadlock.
(@dealiiVideoLectureSeeAlso{39,41,41.25,41.5})
In practice, one does not usually program at the level of sending and
@@ -177,7 +177,7 @@ philosophy behind MPI as outlined above.
The techniques this program then demonstrates are:
- How to use the PETSc wrapper classes; this will already be visible in the
declaration of the principal class of this program, ElasticProblem
.
-- How to partition the mesh into subdomains; this happens in the
+- How to partition the mesh into subdomains; this happens in the
ElasticProblem::setup_system()
function.
- How to parallelize operations for jobs running on an MPI network; here, this
is something one has to pay attention to in a number of places, most
diff --git a/examples/step-17/doc/results.dox b/examples/step-17/doc/results.dox
index f8d96b5cd3..5d732f136a 100644
--- a/examples/step-17/doc/results.dox
+++ b/examples/step-17/doc/results.dox
@@ -104,7 +104,7 @@ relevant to when the code was initially written, in 2004.) I lost the timing
information for the last step, though, but you get the idea. All this is after
release mode has been enabled by running make release
, and
with the generation of graphical output switched off for the reasons stated in
-the program comments above.
+the program comments above.
(@dealiiVideoLectureSeeAlso{18})
The biggest 2d computations I did had roughly 7.1
million unknowns, and were done on 32 processes. It took about 40 minutes.
@@ -237,7 +237,7 @@ the right one shows the x-displacement along two cutplanes through the cube.
The program keeps a complete copy of the Triangulation and DoFHandler objects
on every processor. It also creates complete copies of the solution vector,
and it creates output on only one processor. All of this is obviously
-the bottleneck as far as parallelization is concerned.
+the bottleneck as far as parallelization is concerned.
Internally, within deal.II, parallelizing the data
structures used in hierarchic and unstructured triangulations is a hard
diff --git a/examples/step-18/doc/intro.dox b/examples/step-18/doc/intro.dox
index 79669864c2..222436a664 100644
--- a/examples/step-18/doc/intro.dox
+++ b/examples/step-18/doc/intro.dox
@@ -196,7 +196,7 @@ such that
(\mathbf{f}, \varphi)_{\Omega(t_{n-1})}
-(\sigma^{n-1},\varepsilon(\varphi))_{\Omega(t_{n-1})}
\\
- &\qquad
+ &\qquad
+(\mathbf{b}(\mathbf{x},t_n)-\mathbf{b}(\mathbf{x},t_{n-1}), \varphi)_{\Gamma_N}
+(\sigma^{n-1} \mathbf{n}, \varphi)_{\Gamma_N}
\\
@@ -367,8 +367,8 @@ the correct files and allow moving around in time, both support record files
that reference all files for a given timestep. Sadly, the record files have a
different format between VisIt and Paraview, so we write out both formats.
-The code will generate the files solution-TTTT.NNN.vtu
,
-where TTTT
is the timestep number (starting from 1) and
+The code will generate the files solution-TTTT.NNN.vtu
,
+where TTTT
is the timestep number (starting from 1) and
NNN
is the process rank (starting from
0). These files contain the locally owned cells for the timestep and
processor. The files solution-TTTT.visit
is the visit record
@@ -401,14 +401,14 @@ partitions itself among all involved processes (which it knows about because
you have to tell it about the @ref GlossMPICommunicator "MPI communicator"
that connects these processes upon construction of the triangulation).
Otherwise, the parallel::shared::Triangulation looks, for all practical
-purposes, like a regular Triangulation object.
+purposes, like a regular Triangulation object.
The convenience of using this class does not only result from being able
to avoid the manual call to GridTools::partition(). Rather, the DoFHandler
class now also knows that you want to use it in a parallel context, and
by default automatically enumerates degrees of freedom in such a way
that all DoFs owned by process zero come before all DoFs owned by process 1,
-etc. In other words, you can also avoid the call to
+etc. In other words, you can also avoid the call to
DoFRenumbering::subdomain_wise().
There are other benefits. For example, because the triangulation knows that
@@ -424,7 +424,7 @@ using the syntax
@endcode
This knowledge extends to the DoFHandler object built on such triangulations,
which can then identify which degrees of freedom are locally owned
-(see @ref GlossLocallyOwnedDofs) via calls such as
+(see @ref GlossLocallyOwnedDofs) via calls such as
DoFHandler::compute_n_locally_owned_dofs_per_processor() and
DoFTools::extract_locally_relevant_dofs(). Finally, the DataOut class
also knows how to deal with such triangulations and will simply skip
diff --git a/examples/step-18/doc/results.dox b/examples/step-18/doc/results.dox
index 80a08a9cdb..e647b34585 100644
--- a/examples/step-18/doc/results.dox
+++ b/examples/step-18/doc/results.dox
@@ -472,7 +472,7 @@ solution of such problems, and stabilization techniques have to be employed
for a stable and accurate solution. The book and paper cited above give
indications as to how to do this, but there is also a large volume of
literature on this subject; a good start to get an overview of the topic can
-be found in the references of the paper by H.-Y. Duan and Q. Lin; @cite DL05.
+be found in the references of the paper by H.-Y. Duan and Q. Lin; @cite DL05.
unsigned int n_refinement_steps
, which will be used for the output filename.
+To fully make use of the automation we first need to introduce a private variable for the number of
+global refinement steps unsigned int n_refinement_steps
, which will be used for the output filename.
In make_grid()
we then replace triangulation.refine_global(5);
with
@code
n_refinement_steps = 5;
@@ -243,8 +243,8 @@ triangulation.refine_global(n_refinement_steps);
The deal.II library has two different %HDF5 bindings, one in the HDF5
namespace (for interfacing to general-purpose data files)
and another one in DataOut (specifically for writing files for the
-visualization of solutions).
-Although the HDF5 deal.II binding supports both serial and MPI, the %HDF5 DataOut binding
+visualization of solutions).
+Although the HDF5 deal.II binding supports both serial and MPI, the %HDF5 DataOut binding
only supports parallel output.
For this reason we need to initialize an MPI
communicator with only one processor. This is done by adding the following code.
@@ -269,7 +269,7 @@ the original version of the tutorial produces; but, since %HDF5 is a
more general file format, it can also easily be processed in scripting
languages for other purposes.
-
+
h5f\$name
. The function
@@ -350,8 +350,8 @@ The datasets can be accessed by h5f\$name
. The function
that is used to store our cells.
We can see the following three matrices, as well as the two
additional data points we added.
-cells
: a 4x1024 matrix that stores the (C++) vertex indices for each cell
+cells
: a 4x1024 matrix that stores the (C++) vertex indices for each cell
nodes
: a 2x1089 matrix storing the position values (x,y) for our cell vertices
solution
: a 1x1089 matrix storing the values of our solution at each vertex
data.frame
.
After that, a ggplot
object is constructed and manipulated by adding plot elements to it.
-nodes
and cells
contain all the information we need to plot our grid.
+nodes
and cells
contain all the information we need to plot our grid.
The following code wraps all the data into one dataframe for plotting our grid:
@code{.r}
# Counting in R starts at 1 instead of 0, so we need to increment all
@@ -383,7 +383,7 @@ With the finished dataframe we have everything we need to plot our grid:
@code{.r}
pdf (paste("grid_",refinement,".pdf",sep=""),width = 5,height = 5) # Open new PDF file
plt <- ggplot(meshdata,aes(x=x,y=y,group=id)) # Construction of our plot
- # object, at first only data
+ # object, at first only data
plt <- plt + geom_polygon(fill="white",colour="black") # Actual plotting of the grid as polygons
plt <- plt + ggtitle(paste("grid at refinement level #",refinement))
@@ -406,7 +406,7 @@ We can also visualize the solution itself, and this is going to look
more interesting.
To make a 2D pseudocolor plot of our solution we will use geom_raster
.
This function needs a structured grid, i.e. uniform in x and y directions.
-Luckily our data at this point is structured in the right way.
+Luckily our data at this point is structured in the right way.
The following code plots a pseudocolor representation of our surface into a new PDF:
@code{.r}
pdf (paste("pseudocolor_",refinement,".pdf",sep=""),width = 5,height = 4.2) # Open new PDF file
@@ -428,10 +428,10 @@ This is now going to look as follows:
-n_refinement_steps
-starting from 1.
+starting from 1.
Since every file only contains a single data point we need to loop over them and concatenate the results into a single vector.
@code{.r}
n_ref <- 8 # Maximum refinement level for which results are existing
@@ -492,5 +492,5 @@ to zero:
EigenvalueProblem
) now no
longer has a single solution vector, but a whole set of vectors for
@@ -265,5 +265,5 @@ formula.solution-2d.vtk
and
solution-3d.vtk
, which can be viewed using the programs
Visit or Paraview (in case you do not have these programs, you can easily
-change the
+change the
output format in the program to something which you can view more
easily). Visualizing solutions is a bit of an art, but it can also be fun, so
you should play around with your favorite visualization tool to get familiar
@@ -90,7 +90,7 @@ used to generate these pictures, Visit, by default puts tick marks on every
axis, puts a big fat label "X Axis" on the $x$ axis and similar for the other
axes, shows the file name from which the data was taken in the top left and
the name of the user doing so and the time and date on the bottom right. None
-of this is important
+of this is important
here: the axes are equally easy to make out because the tripod at the bottom
left is still visible, and we know from the program that the domain is
$[-1,1]^3$, so there is no need for tick marks. As a consequence, I have
diff --git a/examples/step-42/doc/intro.dox b/examples/step-42/doc/intro.dox
index aaabb4fbc7..527516706d 100644
--- a/examples/step-42/doc/intro.dox
+++ b/examples/step-42/doc/intro.dox
@@ -413,7 +413,7 @@ Other than that, let us comment only on the following aspects:
move_mesh()
function. However, because the indentation of the obstacles we consider here
diff --git a/examples/step-44/doc/intro.dox b/examples/step-44/doc/intro.dox
index 95ce4fe00d..a105f1faef 100644
--- a/examples/step-44/doc/intro.dox
+++ b/examples/step-44/doc/intro.dox
@@ -3,7 +3,7 @@
This program was contributed by Jean-Paul Pelteret and Andrew McBride.
push_forward()
that takes a point
in the reference domain $\hat U$ and transform it into real space using the function
@@ -255,8 +255,8 @@ that looks, in essence, like this:
@endcode
The transformations above have two parts: the WGS 84 transformations and the topography
-transformation. Consequently, the AfricaGeometry
class will have
-additional (non-virtual) member functions
+transformation. Consequently, the AfricaGeometry
class will have
+additional (non-virtual) member functions
AfricaGeometry::push_forward_wgs84()
and
AfricaGeometry::push_forward_topo()
that implement these two pieces, and
corresponding pull back functions.
@@ -289,7 +289,7 @@ looks like this:
@endcode
The data is formatted as latitude longitude elevation
where the first two
columns are provided in degrees North of the equator and degrees East of the Greenwich
-meridian. The final column is given in meters above the WGS 84 zero elevation.
+meridian. The final column is given in meters above the WGS 84 zero elevation.
In the transformation functions, we need to evaluate $h(\hat\phi,\hat\theta)$ for a given
longitude $\hat\phi$ and latitude $\hat\theta$. In general, this data point will not be
@@ -298,11 +298,11 @@ interpolation routine is not particularly difficult, but it is a bit tedious and
prone. Fortunately, we can somehow shoehorn this data set into an existing class:
Functions::InterpolatedUniformGridData . Unfortunately, the class does not fit the bill
quite exactly and so we need to work around it a bit. The problem comes from the way
-we initialize this class: in its simplest form, it takes a stream of values that it
+we initialize this class: in its simplest form, it takes a stream of values that it
assumes form an equispaced mesh in the $x-y$ plane (or, here, the $\phi-\theta$ plane).
Which is what they do here, sort of: they are ordered latitude first, longitude second;
and more awkwardly, the first column starts at the largest values and counts down,
-rather than the usual other way around.
+rather than the usual other way around.
Now, while tutorial programs are meant to illustrate how to code with deal.II, they do
not necessarily have to satisfy the same quality standards as one would have to do
@@ -316,11 +316,11 @@ Functions::InterpolatedUniformGridData class.
On the other hand, tutorial programs are best if they are short and demonstrate key
points rather than dwell on unimportant aspects and, thereby, obscure what we really
want to show. Consequently, we will allow ourselves a bit of leeway:
-- since this program is intended solely for a particular geometry around the area
- of the East-African rift and since this is precisely the area described by the data
- file, we will hardcode in the program that there are
+- since this program is intended solely for a particular geometry around the area
+ of the East-African rift and since this is precisely the area described by the data
+ file, we will hardcode in the program that there are
$1139\times 660$ pieces of data;
-- we will hardcode the boundaries of the data
+- we will hardcode the boundaries of the data
$[-11.98333^\circ,6.983333^\circ]\times[25^\circ,35.98333^\circ]$;
- we will lie to the Functions::InterpolatedUniformGridData class: the class will
only see the data in the last column of this data file, and we will pretend that
@@ -331,7 +331,7 @@ want to show. Consequently, we will allow ourselves a bit of leeway:
interpolating table class for a value at $-\hat\theta$. With this little
trick, we can avoid having to switch around the order of data as read from
file.
-
+
All of this then calls for a class that essentially looks like this:
@code
class AfricaTopography
diff --git a/examples/step-53/doc/results.dox b/examples/step-53/doc/results.dox
index d953814176..7143ab3236 100644
--- a/examples/step-53/doc/results.dox
+++ b/examples/step-53/doc/results.dox
@@ -7,7 +7,7 @@ to see anything that doesn't just look like a perfectly round piece of a
sphere (though if one modified the program so that it does produce a sphere and
looked at them at the same time, the difference between the overall sphere and
WGS 84 shape is quite apparent). Apparently, Earth is actually quite a flat place.
-Of course we already know this from satellite pictures.
+Of course we already know this from satellite pictures.
However, we can tease out something more by
coloring cells by their volume. This both produces slight variations in hue
along the top surface and something for the visualization programs to apply
@@ -25,7 +25,7 @@ this, with an incredible amount of detail:
A zoom-in of this picture shows the vertical displacement quite clearly (here,
looking from the West-Northwest over the rift valley, the triple peaks
-of
+of
Mount Stanley,
Mount Speke, and
Mount Baker
@@ -39,7 +39,7 @@ and toward the great flatness of
-These image were produced with three small modifications:
+These image were produced with three small modifications:
x
computes the elevation by converting the point to
reference WGS 84 coordinates and only keeping the depth variable (the
function is, consequently, a simplified version of the
@@ -93,7 +93,7 @@ double get_elevation (const Point<3> &x)
5,
ScalarFunctionFromFunctionObject<3>(get_elevation),
boundary_values);
- for (std::mapelevation
vector (leaving all interior degrees of freedom at
their original zero value). This vector is then output using DataOut as
usual and can be visualized as shown above.
diff --git a/examples/step-54/doc/intro.dox b/examples/step-54/doc/intro.dox
index 136d2459f4..3352ba3d04 100644
--- a/examples/step-54/doc/intro.dox
+++ b/examples/step-54/doc/intro.dox
@@ -66,7 +66,7 @@ the OpenCASCADE framework. From a TopoDS_Shape
, it is then possible
to access all the sub-shapes (such as vertices, edges and faces) composing it,
along with their geometrical description. In the deal.II framework, the
topological entities composing a shape are used to create a corresponding
-Manifold representation. In step-6 we saw how to use GridGenerator::hyper_sphere()
+Manifold representation. In step-6 we saw how to use GridGenerator::hyper_sphere()
to create a hyper sphere, which automatically attaches a SphericalManifold
to all boundary faces. This guarantees that boundary faces stay on a
sphere or circle during mesh refinement. The functions of the CAD modeling interface
diff --git a/examples/step-54/doc/results.dox b/examples/step-54/doc/results.dox
index fee51db117..de6f91d648 100644
--- a/examples/step-54/doc/results.dox
+++ b/examples/step-54/doc/results.dox
@@ -1,8 +1,8 @@
3d_mesh_*.vtk
+The program execution produces a series of mesh files 3d_mesh_*.vtk
that we can visualize with any of the usual visualization programs that can read the VTK
-file format.
+file format.
The following table illustrates the results obtained employing the normal projection strategy. The first two
rows of the table show side views of the grids obtained for progressive levels
@@ -17,17 +17,17 @@ same grids shown in the second row.
- | + | ||
- | + | ||
- | + |
- | + | ||
- | + | ||
- | + |
- | + | ||
- | + | ||
- | + |
cell_matrix_D
,
-whereas the matrix with elements
+whereas the matrix with elements
$
\left( \mathbf{Kv}_j,\mathbf{v}_k \right)
$
@@ -449,14 +449,14 @@ is called cell_matrix_E
.
Then the elementwise velocity is
@f{equation*}
-\mathbf{u}_h = -\sum_{i} \sum_{j}P_ic_{ij}\sum_{k}d_{jk}\mathbf{v}_k =
+\mathbf{u}_h = -\sum_{i} \sum_{j}P_ic_{ij}\sum_{k}d_{jk}\mathbf{v}_k =
\sum_{k}- \left(\sum_{j} \sum_{i} P_ic_{ij}d_{jk} \right)\mathbf{v}_k,
@f}
-where $-\sum_{j} \sum_{i} P_ic_{ij}d_{jk}$ is called
+where $-\sum_{j} \sum_{i} P_ic_{ij}d_{jk}$ is called
`cell_velocity` in the code.
Using this velocity obtained by "postprocessing" the solution, we can
-define the $L_2$-errors of pressure, velocity, and flux
+define the $L_2$-errors of pressure, velocity, and flux
by the following formulas:
@f{align*}{
\|p-p_h^\circ\|^2
@@ -467,8 +467,8 @@ by the following formulas:
&= \sum_{K \in \mathbb{T}} \sum_{\gamma \subset \partial K}
\frac{|K|}{|\gamma|} \|\mathbf{u} \cdot \mathbf{n} - \mathbf{u}_h \cdot \mathbf{n}\|_{L_2(\gamma)}^2,
@f}
-where $| K |$ is the area of the element,
-$\gamma$ are faces of the element,
+where $| K |$ is the area of the element,
+$\gamma$ are faces of the element,
$\mathbf{n}$ are unit normal vectors of each face. The last of these
norms measures the accuracy of the normal component of the velocity
vectors over the interfaces between the cells of the mesh. The scaling
diff --git a/examples/step-61/doc/results.dox b/examples/step-61/doc/results.dox
index d77f37291e..7b2b90d311 100644
--- a/examples/step-61/doc/results.dox
+++ b/examples/step-61/doc/results.dox
@@ -37,17 +37,17 @@ pressures $p^\circ$ on the two adjacent cells.
-From the figures, we can see that with the mesh refinement, the maximum and
-minimum pressure values are approaching the values we expect.
-Since the mesh is a rectangular mesh and numbers of cells in each direction is even, we
-have symmetric solutions. From the 3d figures on the right,
+From the figures, we can see that with the mesh refinement, the maximum and
+minimum pressure values are approaching the values we expect.
+Since the mesh is a rectangular mesh and numbers of cells in each direction is even, we
+have symmetric solutions. From the 3d figures on the right,
we can see that on $\mbox{WG}(Q_0,Q_0;RT_{[0]})$, the pressure is a constant
in the interior of the cell, as expected.