From e552602e5d8981f20df1a0cf7f551a16d035dde5 Mon Sep 17 00:00:00 2001
From: David Wells
Date: Sat, 25 Apr 2015 11:57:29 -0400
Subject: [PATCH] Remove references to the STL. These comments should refer to
the C++ standard instead, which now includes the STL (standard template
library).
---
doc/doxygen/headers/coding_conventions.h | 2 +-
doc/doxygen/headers/memory.h | 6 +--
examples/step-14/step-14.cc | 4 +-
examples/step-48/step-48.cc | 37 +++++++++----------
include/deal.II/base/memory_consumption.h | 7 ++--
include/deal.II/base/symmetric_tensor.h | 16 ++++----
include/deal.II/base/table_handler.h | 2 +-
include/deal.II/base/tensor.h | 16 ++++----
include/deal.II/base/tensor_base.h | 34 ++++++++---------
include/deal.II/base/vector_slice.h | 8 ++--
include/deal.II/dofs/function_map.h | 2 +-
.../deal.II/grid/grid_reordering_internal.h | 2 +-
include/deal.II/grid/tria.h | 26 ++++++-------
include/deal.II/grid/tria_iterator.h | 17 ++++-----
include/deal.II/lac/block_matrix_base.h | 11 +++---
include/deal.II/lac/chunk_sparse_matrix.h | 32 ++++++++--------
include/deal.II/lac/chunk_sparsity_pattern.h | 17 ++++-----
.../deal.II/lac/constraint_matrix.templates.h | 9 +++--
.../deal.II/lac/dynamic_sparsity_pattern.h | 6 +--
include/deal.II/lac/filtered_matrix.h | 2 +-
include/deal.II/lac/full_matrix.h | 9 +++--
include/deal.II/lac/matrix_iterator.h | 2 +-
include/deal.II/lac/petsc_matrix_base.h | 12 +++---
include/deal.II/lac/precondition_block.h | 6 +--
include/deal.II/lac/sparse_matrix.h | 18 ++++-----
include/deal.II/lac/sparse_matrix_ez.h | 11 +++---
include/deal.II/lac/sparsity_pattern.h | 12 +++---
include/deal.II/lac/trilinos_sparse_matrix.h | 6 +--
.../deal.II/lac/trilinos_sparsity_pattern.h | 4 +-
include/deal.II/lac/vector.h | 8 ++--
source/grid/grid_refinement.cc | 10 ++---
31 files changed, 174 insertions(+), 180 deletions(-)
diff --git a/doc/doxygen/headers/coding_conventions.h b/doc/doxygen/headers/coding_conventions.h
index 57d96575d8..116f789161 100644
--- a/doc/doxygen/headers/coding_conventions.h
+++ b/doc/doxygen/headers/coding_conventions.h
@@ -124,7 +124,7 @@ style guidelines outlined in this page.
use lowercase letters and underscores to separate words.
The only exception are the iterator typedefs in Triangulation
and DoFHandler (named cell_iterator, active_line_iterator, etc)
- to make the connection to the STL classes clear.
+ to make the connection to the standard library container classes clear.
For classes with multiple template arguments, the dimension is usually
put before the data type specifier, i.e., we use Point and not
diff --git a/doc/doxygen/headers/memory.h b/doc/doxygen/headers/memory.h
index 70b2351634..0eb7937ba8 100644
--- a/doc/doxygen/headers/memory.h
+++ b/doc/doxygen/headers/memory.h
@@ -30,9 +30,9 @@
*
* In contrast to this, the MemoryConsumption namespace provides
* functions that can be used to determine the memory consumption of
- * objects. For some simple classes, like the STL containers, it
- * directly determines how much memory they need (or at least gives an
- * estimate). For deal.II classes, it uses the
+ * objects. For some simple classes, like the standard library
+ * containers, it directly determines how much memory they need (or at
+ * least gives an estimate). For deal.II classes, it uses the
* memory_consumption
member function that most classes
* have.
*
diff --git a/examples/step-14/step-14.cc b/examples/step-14/step-14.cc
index e6c93cea4c..1947f9dd80 100644
--- a/examples/step-14/step-14.cc
+++ b/examples/step-14/step-14.cc
@@ -1441,8 +1441,8 @@ namespace Step14
const unsigned int
n_vertices = sizeof(vertices_1) / sizeof(vertices_1[0]);
- // From this static list of vertices, we generate an STL vector of the
- // vertices, as this is the data type the library wants to see.
+ // From this static list of vertices, we generate a std::vector
+ // of the vertices, as this is the data type the library wants to see.
const std::vector > vertices (&vertices_1[0],
&vertices_1[n_vertices]);
diff --git a/examples/step-48/step-48.cc b/examples/step-48/step-48.cc
index 030d409289..e567594c3f 100644
--- a/examples/step-48/step-48.cc
+++ b/examples/step-48/step-48.cc
@@ -162,23 +162,22 @@ namespace Step48
// The nonlinear function that we have to evaluate for the time stepping
// routine includes the value of the function at the present time @p current
// as well as the value at the previous time step @p old. Both values are
- // passed to the operator in the collection of source vectors @p src, which
- // is simply an STL vector of pointers to the actual solution vectors. This
- // construct of collecting several source vectors into one is necessary as
- // the cell loop in @p MatrixFree takes exactly one source and one
- // destination vector, even if we happen to use many vectors like the two in
- // this case. Note that the cell loop accepts any valid class for input and
- // output, which does not only include vectors but general data
- // types. However, only in case it encounters a
- // parallel::distributed::Vector or an STL vector collecting these
- // vectors, it calls functions that exchange data at the beginning and the
- // end of the loop. In the loop over the cells, we first have to read in the
- // values in the vectors related to the local values. Then, we evaluate the
- // value and the gradient of the current solution vector and the values of
- // the old vector at the quadrature points. Then, we combine the terms in
- // the scheme in the loop over the quadrature points. Finally, we integrate
- // the result against the test function and accumulate the result to the
- // global solution vector @p dst.
+ // passed to the operator in the collection of source vectors @p src, which is
+ // simply a std::vector of pointers to the actual solution
+ // vectors. This construct of collecting several source vectors into one is
+ // necessary as the cell loop in @p MatrixFree takes exactly one source and
+ // one destination vector, even if we happen to use many vectors like the two
+ // in this case. Note that the cell loop accepts any valid class for input and
+ // output, which does not only include vectors but general data types.
+ // However, only in case it encounters a parallel::distributed::Vector
+ // or a std::vector collecting these vectors, it calls functions that
+ // exchange data at the beginning and the end of the loop. In the loop over
+ // the cells, we first have to read in the values in the vectors related to
+ // the local values. Then, we evaluate the value and the gradient of the
+ // current solution vector and the values of the old vector at the quadrature
+ // points. Then, we combine the terms in the scheme in the loop over the
+ // quadrature points. Finally, we integrate the result against the test
+ // function and accumulate the result to the global solution vector @p dst.
template
void SineGordonOperation::
local_apply (const MatrixFree &data,
@@ -541,8 +540,8 @@ namespace Step48
// artificial time.
// We create an output of the initial value. Then we also need to collect
- // the two starting solutions in an STL vector of pointers field and to
- // set up an instance of the SineGordonOperation class
+ // the two starting solutions in a std::vector of pointers field
+ // and to set up an instance of the SineGordonOperation class
// based on the finite element degree specified at the top of this file.
VectorTools::interpolate (dof_handler,
ExactSolution (1, time),
diff --git a/include/deal.II/base/memory_consumption.h b/include/deal.II/base/memory_consumption.h
index 9fc7eeb371..66ecc8e6e6 100644
--- a/include/deal.II/base/memory_consumption.h
+++ b/include/deal.II/base/memory_consumption.h
@@ -35,9 +35,8 @@ template class VectorizedArray;
/**
* This namespace provides functions helping to determine the amount of memory
* used by objects. The goal is not necessarily to give the amount of memory
- * used up to the last bit (what is the memory used by an STL
- * std::map<> object?), but rather to aid in the search for memory
- * bottlenecks.
+ * used up to the last bit (what is the memory used by a std::map
+ * object?), but rather to aid in the search for memory bottlenecks.
*
* This namespace has a single member function memory_consumption() and a lot
* of specializations. Depending on the argument type of the function, there
@@ -228,7 +227,7 @@ namespace MemoryConsumption
/**
* Estimate the amount of memory (in bytes) occupied by a C-style array.
* Since in this library we do not usually store simple data elements like
- * doubles in such arrays (but rather use STL std::vectors
+ * doubles in such arrays (but rather use std::vectors
* or deal.II Vector objects), we do not provide specializations
* like for the std::vector arrays, but always use the loop over
* all elements.
diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h
index 4958cbf3c6..8786247ead 100644
--- a/include/deal.II/base/symmetric_tensor.h
+++ b/include/deal.II/base/symmetric_tensor.h
@@ -752,14 +752,14 @@ public:
/**
* Reset all values to zero.
*
- * Note that this is partly inconsistent with the semantics of the @p
- * clear() member functions of the STL and of several other classes within
- * deal.II which not only reset the values of stored elements to zero, but
- * release all memory and return the object into a virginial state. However,
- * since the size of objects of the present type is determined by its
- * template parameters, resizing is not an option, and indeed the state
- * where all elements have a zero value is the state right after
- * construction of such an object.
+ * Note that this is partly inconsistent with the semantics of the @p clear()
+ * member functions of the standard library containers and of several other
+ * classes within deal.II, which not only reset the values of stored elements
+ * to zero, but release all memory and return the object into a virginial
+ * state. However, since the size of objects of the present type is determined
+ * by its template parameters, resizing is not an option, and indeed the state
+ * where all elements have a zero value is the state right after construction
+ * of such an object.
*/
void clear ();
diff --git a/include/deal.II/base/table_handler.h b/include/deal.II/base/table_handler.h
index 8f5e52e316..2595131e79 100644
--- a/include/deal.II/base/table_handler.h
+++ b/include/deal.II/base/table_handler.h
@@ -526,7 +526,7 @@ protected:
struct Column
{
/**
- * Constructor needed by STL maps.
+ * Constructor needed by std::map.
*/
Column ();
diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h
index f013d7c58d..5a6076d69f 100644
--- a/include/deal.II/base/tensor.h
+++ b/include/deal.II/base/tensor.h
@@ -274,14 +274,14 @@ public:
/**
* Reset all values to zero.
*
- * Note that this is partly inconsistent with the semantics of the @p
- * clear() member functions of the STL and of several other classes within
- * deal.II which not only reset the values of stored elements to zero, but
- * release all memory and return the object into a virginial state. However,
- * since the size of objects of the present type is determined by its
- * template parameters, resizing is not an option, and indeed the state
- * where all elements have a zero value is the state right after
- * construction of such an object.
+ * Note that this is partly inconsistent with the semantics of the @p clear()
+ * member functions of the standard library containers and of several other
+ * classes within deal.II, which not only reset the values of stored elements
+ * to zero, but release all memory and return the object into a virginial
+ * state. However, since the size of objects of the present type is determined
+ * by its template parameters, resizing is not an option, and indeed the state
+ * where all elements have a zero value is the state right after construction
+ * of such an object.
*/
void clear ();
diff --git a/include/deal.II/base/tensor_base.h b/include/deal.II/base/tensor_base.h
index 4b2538aa3d..2ce8f72bb0 100644
--- a/include/deal.II/base/tensor_base.h
+++ b/include/deal.II/base/tensor_base.h
@@ -244,14 +244,14 @@ public:
/**
* Reset all values to zero.
*
- * Note that this is partly inconsistent with the semantics of the @p
- * clear() member functions of the STL and of several other classes within
- * deal.II which not only reset the values of stored elements to zero, but
- * release all memory and return the object into a virginial state. However,
- * since the size of objects of the present type is determined by its
- * template parameters, resizing is not an option, and indeed the state
- * where all elements have a zero value is the state right after
- * construction of such an object.
+ * Note that this is partly inconsistent with the semantics of the @p clear()
+ * member functions of the standard library containers and of several other
+ * classes within deal.II, which not only reset the values of stored elements
+ * to zero, but release all memory and return the object into a virginial
+ * state. However, since the size of objects of the present type is determined
+ * by its template parameters, resizing is not an option, and indeed the state
+ * where all elements have a zero value is the state right after construction
+ * of such an object.
*/
void clear ();
@@ -512,14 +512,14 @@ public:
/**
* Reset all values to zero.
*
- * Note that this is partly inconsistent with the semantics of the @p
- * clear() member functions of the STL and of several other classes within
- * deal.II which not only reset the values of stored elements to zero, but
- * release all memory and return the object into a virginial state. However,
- * since the size of objects of the present type is determined by its
- * template parameters, resizing is not an option, and indeed the state
- * where all elements have a zero value is the state right after
- * construction of such an object.
+ * Note that this is partly inconsistent with the semantics of the @p clear()
+ * member functions of the standard library containers and of several other
+ * classes within deal.II, which not only reset the values of stored elements
+ * to zero, but release all memory and return the object into a virginial
+ * state. However, since the size of objects of the present type is determined
+ * by its template parameters, resizing is not an option, and indeed the state
+ * where all elements have a zero value is the state right after construction
+ * of such an object.
*/
void clear ();
@@ -1550,5 +1550,3 @@ operator * (const std::complex factor,
DEAL_II_NAMESPACE_CLOSE
#endif
-
-
diff --git a/include/deal.II/base/vector_slice.h b/include/deal.II/base/vector_slice.h
index b6ce176c0c..01ae61cfaa 100644
--- a/include/deal.II/base/vector_slice.h
+++ b/include/deal.II/base/vector_slice.h
@@ -82,22 +82,22 @@ public:
typename VECTOR::const_reference operator[] (unsigned int i) const;
/**
- * STL conforming iterator function.
+ * Standard-conforming iterator function.
*/
typename VECTOR::iterator begin();
/**
- * STL conforming iterator function.
+ * Standard-conforming iterator function.
*/
typename VECTOR::const_iterator begin() const;
/**
- * STL conforming iterator function.
+ * Standard-conforming iterator function.
*/
typename VECTOR::iterator end();
/**
- * STL conforming iterator function.
+ * Standard-conforming iterator function.
*/
typename VECTOR::const_iterator end() const;
diff --git a/include/deal.II/dofs/function_map.h b/include/deal.II/dofs/function_map.h
index c66a700d9a..e15537d374 100644
--- a/include/deal.II/dofs/function_map.h
+++ b/include/deal.II/dofs/function_map.h
@@ -69,7 +69,7 @@ struct FunctionMap
/**
* Declare the type as discussed above. Since we can't name it FunctionMap
* (as that would ambiguate a possible constructor of this class), name it
- * in the fashion of the STL local typedefs.
+ * in the fashion of the standard container local typedefs.
*/
typedef std::map*> type;
};
diff --git a/include/deal.II/grid/grid_reordering_internal.h b/include/deal.II/grid/grid_reordering_internal.h
index a54d28e190..3ae7689e9d 100644
--- a/include/deal.II/grid/grid_reordering_internal.h
+++ b/include/deal.II/grid/grid_reordering_internal.h
@@ -371,7 +371,7 @@ namespace internal
const unsigned int n1);
/**
- * Need a partial ordering for the STL
+ * Need a partial ordering for sorting algorithms
*/
bool operator< (const CheapEdge &e2) const;
};
diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h
index 2cbb457225..f35d4aa0d8 100644
--- a/include/deal.II/grid/tria.h
+++ b/include/deal.II/grid/tria.h
@@ -435,15 +435,14 @@ namespace internal
* quite inconvenient if one attempted to operate on it directly, since data
* is spread over quite a lot of arrays and other places. However, there are
* ways powerful enough to work on these data structures without knowing their
- * exact relations. This is done through the concept of iterators (see the STL
- * documentation and TriaIterator). In order to make things as easy and
- * dimension independent as possible, use of class local typedefs is made, see
- * below.
+ * exact relations. deal.II uses class local typedefs (see below) to make things
+ * as easy and dimension independent as possible.
*
- * The Triangulation class provides iterator which enable looping over all
- * cells without knowing the exact representation used to describe them. Their
- * names are typedefs imported from the Iterators class (thus making them
- * local types to this class) and are as follows:
+ * The Triangulation class provides iterators which enable looping over all
+ * cells without knowing the exact representation used to describe them. For
+ * more information see the documentation of TriaIterator. Their names
+ * are typedefs imported from the Iterators class (thus making them local types
+ * to this class) and are as follows:
*
*
* - cell_iterator: loop over all cells used in the Triangulation
@@ -475,10 +474,11 @@ namespace internal
* functions returning iterators. Take a look at the class doc to get an
* overview.
*
- * Usage of these iterators works mostly like with the STL iterators. Some
- * examples taken from the Triangulation source code follow (notice that in
- * the last two examples the template parameter @p spacedim has been omitted,
- * so it takes the default value
dim
).
+ * Usage of these iterators is similar to usage of standard container
+ * iterators. Some examples taken from the Triangulation source code follow
+ * (notice that in the last two examples the template parameter @p spacedim has
+ * been omitted, so it takes the default value dim
).
+ *
*
* - Counting the number of cells on a specific level
* @code
@@ -492,7 +492,7 @@ namespace internal
* return n;
* };
* @endcode
- * Another way which uses the STL @p distance function would be to write
+ * Another way, which uses std::distance, would be to write
* @code
* template
* int Triangulation::n_cells (const int level) const {
diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h
index ca04ef54de..ae61e087ae 100644
--- a/include/deal.II/grid/tria_iterator.h
+++ b/include/deal.II/grid/tria_iterator.h
@@ -49,13 +49,12 @@ template class TriaActiveIterator;
/**
- * This class implements an iterator, analogous to those of the standard
- * template library (STL). It fulfills the requirements of a bidirectional
- * iterator. See the C++ documentation for further details of iterator
- * specification and usage.
+ * This class implements an iterator, analogous to those used in the standard
+ * library. It fulfills the requirements of a bidirectional iterator. See the
+ * C++ documentation for further details of iterator specification and usage.
*
*
- * In addition to the STL iterators an iterator of this class provides a
+ * In addition to the standard interface, an iterator of this class provides a
* -@> operator, i.e. you can write statements like
* @code
* i->set_refine_flag ();
@@ -120,10 +119,10 @@ template class TriaActiveIterator;
* more functionality.
*
* Furthermore, the iterators described here satisfy the requirement of input
- * and bidirectional iterators as stated by the C++ standard and the STL
- * documentation. It is therefore possible to use the functions from the
- * algorithm section of the C++ standard, e.g. count_if (see the
- * documentation for Triangulation for an example) and several others.
+ * and bidirectional iterators as stated by the C++ standard. It is therefore
+ * possible to use the functions from the algorithm section of the C++ standard,
+ * e.g., count_if (see the documentation for Triangulation for an
+ * example) and several others.
*
*
Implementation
*
diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h
index 781a5e1e78..4916dbc8f6 100644
--- a/include/deal.II/lac/block_matrix_base.h
+++ b/include/deal.II/lac/block_matrix_base.h
@@ -347,7 +347,8 @@ public:
typedef MatrixType BlockType;
/**
- * Type of matrix entries. In analogy to the STL container classes.
+ * Type of matrix entries. These are analogous to typedefs in the standard
+ * library containers.
*/
typedef typename BlockType::value_type value_type;
typedef value_type *pointer;
@@ -697,7 +698,7 @@ public:
const bool alternative_output = false) const;
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
iterator begin ();
@@ -707,7 +708,7 @@ public:
iterator end ();
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*/
iterator begin (const size_type r);
@@ -716,7 +717,7 @@ public:
*/
iterator end (const size_type r);
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
const_iterator begin () const;
@@ -726,7 +727,7 @@ public:
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*/
const_iterator begin (const size_type r) const;
diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h
index d0250b5b1e..44606bc371 100644
--- a/include/deal.II/lac/chunk_sparse_matrix.h
+++ b/include/deal.II/lac/chunk_sparse_matrix.h
@@ -273,7 +273,7 @@ namespace ChunkSparseMatrixIterators
/**
- * STL conforming iterator for constant and non-constant matrices.
+ * Iterator for constant and non-constant matrices.
*
* The first template argument denotes the underlying numeric type, the
* second the constness of the matrix.
@@ -415,7 +415,8 @@ public:
typedef types::global_dof_index size_type;
/**
- * Type of matrix entries. In analogy to the STL container classes.
+ * Type of matrix entries. This typedef is analogous to value_type in
+ * the standard library containers.
*/
typedef number value_type;
@@ -431,19 +432,18 @@ public:
typedef typename numbers::NumberTraits::real_type real_type;
/**
- * Typedef of an STL conforming iterator class walking over all the nonzero
- * entries of this matrix. This iterator cannot change the values of the
- * matrix.
+ * Typedef of an iterator class walking over all the nonzero entries of this
+ * matrix. This iterator cannot change the values of the matrix.
*/
typedef
ChunkSparseMatrixIterators::Iterator
const_iterator;
/**
- * Typedef of an STL conforming iterator class walking over all the nonzero
- * entries of this matrix. This iterator @em can change the values of the
- * matrix, but of course can't change the sparsity pattern as this is fixed
- * once a sparse matrix is attached to it.
+ * Typedef of an iterator class walking over all the nonzero entries of this
+ * matrix. This iterator @em can change the values of the matrix, but of
+ * course can't change the sparsity pattern as this is fixed once a sparse
+ * matrix is attached to it.
*/
typedef
ChunkSparseMatrixIterators::Iterator
@@ -1095,8 +1095,8 @@ public:
//@{
/**
- * STL-like iterator with the first entry of the matrix. This is the version
- * for constant matrices.
+ * Iterator starting at first entry of the matrix. This is the version for
+ * constant matrices.
*
* Note that due to the layout in ChunkSparseMatrix, iterating over matrix
* entries is considerably slower than for a sparse matrix, as the iterator
@@ -1116,7 +1116,7 @@ public:
const_iterator end () const;
/**
- * STL-like iterator with the first entry of the matrix. This is the version
+ * Iterator starting at the first entry of the matrix. This is the version
* for non-constant matrices.
*
* Note that due to the layout in ChunkSparseMatrix, iterating over matrix
@@ -1137,8 +1137,8 @@ public:
iterator end ();
/**
- * STL-like iterator with the first entry of row r. This is the
- * version for constant matrices.
+ * Iterator starting at the first entry of row r. This is the version
+ * for constant matrices.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
@@ -1169,8 +1169,8 @@ public:
const_iterator end (const unsigned int r) const;
/**
- * STL-like iterator with the first entry of row r. This is the
- * version for non-constant matrices.
+ * Iterator starting at the first entry of row r. This is the version
+ * for non-constant matrices.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h
index 18212d0bdf..37c1b7e0da 100644
--- a/include/deal.II/lac/chunk_sparsity_pattern.h
+++ b/include/deal.II/lac/chunk_sparsity_pattern.h
@@ -152,7 +152,7 @@ namespace ChunkSparsityPatternIterators
/**
- * STL conforming iterator walking over the elements of a sparsity pattern.
+ * Iterator that walks over the elements of a sparsity pattern.
*/
class Iterator
{
@@ -272,13 +272,13 @@ public:
* Copy constructor. This constructor is only allowed to be called if the
* matrix structure to be copied is empty. This is so in order to prevent
* involuntary copies of objects for temporaries, which can use large
- * amounts of computing time. However, copy constructors are needed if yo
- * want to use the STL data types on classes like this, e.g. to write such
+ * amounts of computing time. However, copy constructors are needed if one
+ * wants to place a ChunkSparsityPattern in a container, e.g., to write such
* statements like v.push_back (ChunkSparsityPattern());, with
* v a vector of ChunkSparsityPattern objects.
*
- * Usually, it is sufficient to use the explicit keyword to disallow
- * unwanted temporaries, but for the STL vectors, this does not work. Since
+ * Usually, it is sufficient to use the explicit keyword to disallow unwanted
+ * temporaries, but this does not work for std::vector. Since
* copying a structure like this is not useful anyway because multiple
* matrices can use the same sparsity structure, copies are only allowed for
* empty objects, as described above.
@@ -621,9 +621,8 @@ public:
bool stores_only_added_elements () const;
/**
- * STL-like iterator with the first entry of the matrix. The resulting
- * iterator can be used to walk over all nonzero entries of the sparsity
- * pattern.
+ * Iterator starting at the first entry of the matrix. The resulting iterator
+ * can be used to walk over all nonzero entries of the sparsity pattern.
*/
iterator begin () const;
@@ -633,7 +632,7 @@ public:
iterator end () const;
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/constraint_matrix.templates.h b/include/deal.II/lac/constraint_matrix.templates.h
index 835988e11d..696e9a3afb 100644
--- a/include/deal.II/lac/constraint_matrix.templates.h
+++ b/include/deal.II/lac/constraint_matrix.templates.h
@@ -2020,10 +2020,11 @@ make_sorted_row_list (const std::vector &local_dof_indices,
// so the first step is to create a sorted list of all row values that are
// possible. these values are either the rows from unconstrained dofs, or
// some indices introduced by dofs constrained to a combination of some
- // other dofs. regarding the data type, choose an STL vector of a pair of
- // unsigned ints (for global columns) and internal data (containing local
- // columns + possible jumps from constraints). Choosing an STL map or
- // anything else M.K. knows of would be much more expensive here!
+ // other dofs. regarding the data type, choose a std::vector of a
+ // pair of unsigned ints (for global columns) and internal data (containing
+ // local columns + possible jumps from constraints). Choosing
+ // std::map or anything else M.K. knows of would be much more
+ // expensive here!
// cache whether we have to resolve any indirect rows generated from
// resolving constrained dofs.
diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h
index 363904ba66..3877c6215f 100644
--- a/include/deal.II/lac/dynamic_sparsity_pattern.h
+++ b/include/deal.II/lac/dynamic_sparsity_pattern.h
@@ -328,7 +328,7 @@ public:
* sparsity structure to be copied is empty. This is so in order to prevent
* involuntary copies of objects for temporaries, which can use large
* amounts of computing time. However, copy constructors are needed if you
- * want to use the STL data types on classes like this, e.g. to write such
+ * want to place a DynamicSparsityPattern in a container, e.g. to write such
* statements like v.push_back (DynamicSparsityPattern());, with
* @p v a vector of @p DynamicSparsityPattern objects.
*/
@@ -473,7 +473,7 @@ public:
// @{
/**
- * STL-like iterator with the first entry of the matrix. The resulting
+ * Iterator starting at the first entry of the matrix. The resulting
* iterator can be used to walk over all nonzero entries of the sparsity
* pattern.
*
@@ -494,7 +494,7 @@ public:
iterator end () const;
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/filtered_matrix.h b/include/deal.II/lac/filtered_matrix.h
index 789461e1e8..f17ea7cb00 100644
--- a/include/deal.II/lac/filtered_matrix.h
+++ b/include/deal.II/lac/filtered_matrix.h
@@ -252,7 +252,7 @@ public:
};
/**
- * STL conforming iterator.
+ * Standard-conforming iterator.
*/
class const_iterator
{
diff --git a/include/deal.II/lac/full_matrix.h b/include/deal.II/lac/full_matrix.h
index 791d27f2fe..fa54d64b7c 100644
--- a/include/deal.II/lac/full_matrix.h
+++ b/include/deal.II/lac/full_matrix.h
@@ -73,7 +73,8 @@ public:
typedef unsigned int size_type;
/**
- * Type of matrix entries. In analogy to the STL container classes.
+ * Type of matrix entries. This typedef is analogous to value_type in
+ * the standard library containers.
*/
typedef number value_type;
@@ -144,7 +145,7 @@ public:
};
/**
- * STL conforming iterator.
+ * Standard-conforming iterator.
*/
class const_iterator
{
@@ -611,7 +612,7 @@ public:
//@{
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
const_iterator begin () const;
@@ -621,7 +622,7 @@ public:
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*/
const_iterator begin (const size_type r) const;
diff --git a/include/deal.II/lac/matrix_iterator.h b/include/deal.II/lac/matrix_iterator.h
index ff39cebf44..1488f44778 100644
--- a/include/deal.II/lac/matrix_iterator.h
+++ b/include/deal.II/lac/matrix_iterator.h
@@ -23,7 +23,7 @@
DEAL_II_NAMESPACE_OPEN
/**
- * STL conforming iterator for constant and non-constant matrices.
+ * Iterator for constant and non-constant matrices.
*
* This iterator is abstracted from the actual matrix type and can be used for
* any matrix having the required ACCESSOR type.
diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h
index 6bcbacbc5a..eb1a3d01be 100644
--- a/include/deal.II/lac/petsc_matrix_base.h
+++ b/include/deal.II/lac/petsc_matrix_base.h
@@ -46,10 +46,10 @@ namespace PETScWrappers
namespace MatrixIterators
{
/**
- * STL conforming iterator. This class acts as an iterator walking over
- * the elements of PETSc matrices. Since PETSc offers a uniform interface
- * for all types of matrices, this iterator can be used to access both
- * sparse and full matrices.
+ * This class acts as an iterator walking over the elements of PETSc
+ * matrices. Since PETSc offers a uniform interface for all types of
+ * matrices, this iterator can be used to access both sparse and full
+ * matrices.
*
* Note that PETSc does not give any guarantees as to the order of
* elements within each row. Note also that accessing the elements of a
@@ -784,7 +784,7 @@ namespace PETScWrappers
const VectorBase &b) const;
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
const_iterator begin () const;
@@ -794,7 +794,7 @@ namespace PETScWrappers
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row @p r.
+ * Iterator starting at the first entry of row @p r.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h
index 51bee4bf01..ac1772c3b1 100644
--- a/include/deal.II/lac/precondition_block.h
+++ b/include/deal.II/lac/precondition_block.h
@@ -386,7 +386,7 @@ public:
typedef types::global_dof_index size_type;
/**
- * STL conforming iterator.
+ * Standard-conforming iterator.
*/
class const_iterator
{
@@ -561,7 +561,7 @@ public:
void Tstep (Vector &dst, const Vector &rhs) const;
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
const_iterator begin () const;
@@ -571,7 +571,7 @@ public:
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row @p r.
+ * Iterator starting at the first entry of row @p r.
*/
const_iterator begin (const size_type r) const;
diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h
index 7a898ddf01..9f200b0cd8 100644
--- a/include/deal.II/lac/sparse_matrix.h
+++ b/include/deal.II/lac/sparse_matrix.h
@@ -292,7 +292,7 @@ namespace SparseMatrixIterators
/**
- * STL conforming iterator for constant and non-constant matrices.
+ * Iterator for constant and non-constant matrices.
*
* The typical use for these iterators is to iterate over the elements of a
* sparse matrix or over the elements of individual rows. Note that there is
@@ -470,7 +470,8 @@ public:
typedef types::global_dof_index size_type;
/**
- * Type of matrix entries. In analogy to the STL container classes.
+ * Type of the matrix entries. This typedef is analogous to
+ * value_type in the standard library containers.
*/
typedef number value_type;
@@ -486,19 +487,18 @@ public:
typedef typename numbers::NumberTraits::real_type real_type;
/**
- * Typedef of an STL conforming iterator class walking over all the nonzero
- * entries of this matrix. This iterator cannot change the values of the
- * matrix.
+ * Typedef of an iterator class walking over all the nonzero entries of this
+ * matrix. This iterator cannot change the values of the matrix.
*/
typedef
SparseMatrixIterators::Iterator
const_iterator;
/**
- * Typedef of an STL conforming iterator class walking over all the nonzero
- * entries of this matrix. This iterator @em can change the values of the
- * matrix, but of course can't change the sparsity pattern as this is fixed
- * once a sparse matrix is attached to it.
+ * Typedef of an iterator class walking over all the nonzero entries of this
+ * matrix. This iterator @em can change the values of the matrix, but of
+ * course can't change the sparsity pattern as this is fixed once a sparse
+ * matrix is attached to it.
*/
typedef
SparseMatrixIterators::Iterator
diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h
index f3067c30f9..964e490d57 100644
--- a/include/deal.II/lac/sparse_matrix_ez.h
+++ b/include/deal.II/lac/sparse_matrix_ez.h
@@ -169,7 +169,7 @@ public:
public:
/**
- * STL conforming iterator.
+ * Standard-conforming iterator.
*/
class const_iterator
{
@@ -289,7 +289,8 @@ public:
};
/**
- * Type of matrix entries. In analogy to the STL container classes.
+ * Type of matrix entries. This typedef is analogous to value_type in
+ * the standard library containers.
*/
typedef number value_type;
@@ -663,7 +664,7 @@ public:
*/
//@{
/**
- * STL-like iterator with the first existing entry.
+ * Iterator starting at the first existing entry.
*/
const_iterator begin () const;
@@ -673,8 +674,8 @@ public:
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row @p r. If this row is empty,
- * the result is end(r), which does NOT point into row @p r..
+ * Iterator starting at the first entry of row @p r. If this row is empty, the
+ * result is end(r), which does NOT point into row @p r.
*/
const_iterator begin (const size_type r) const;
diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h
index d8a0d93a6e..bad861c4d5 100644
--- a/include/deal.II/lac/sparsity_pattern.h
+++ b/include/deal.II/lac/sparsity_pattern.h
@@ -383,13 +383,13 @@ public:
* Copy constructor. This constructor is only allowed to be called if the
* matrix structure to be copied is empty. This is so in order to prevent
* involuntary copies of objects for temporaries, which can use large
- * amounts of computing time. However, copy constructors are needed if yo
- * want to use the STL data types on classes like this, e.g. to write such
+ * amounts of computing time. However, copy constructors are needed if one
+ * wants to place a SparsityPattern in a container, e.g., to write such
* statements like v.push_back (SparsityPattern());, with
* v a vector of SparsityPattern objects.
*
- * Usually, it is sufficient to use the explicit keyword to disallow
- * unwanted temporaries, but for the STL vectors, this does not work. Since
+ * Usually, it is sufficient to use the explicit keyword to disallow unwanted
+ * temporaries, but this does not work for std::vectors. Since
* copying a structure like this is not useful anyway because multiple
* matrices can use the same sparsity structure, copies are only allowed for
* empty objects, as described above.
@@ -675,7 +675,7 @@ public:
// @{
/**
- * STL-like iterator with the first entry of the matrix. The resulting
+ * Iterator starting at the first entry of the matrix. The resulting
* iterator can be used to walk over all nonzero entries of the sparsity
* pattern.
*
@@ -690,7 +690,7 @@ public:
iterator end () const;
/**
- * STL-like iterator with the first entry of row r.
+ * Iterator starting at the first entry of row r.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h
index 220ba8ad6a..e939697e16 100644
--- a/include/deal.II/lac/trilinos_sparse_matrix.h
+++ b/include/deal.II/lac/trilinos_sparse_matrix.h
@@ -322,9 +322,9 @@ namespace TrilinosWrappers
};
/**
- * STL conforming iterator. This class acts as an iterator walking over
- * the elements of Trilinos matrices. The implementation of this class is
- * similar to the one for PETSc matrices.
+ * This class acts as an iterator walking over the elements of Trilinos
+ * matrices. The implementation of this class is similar to the one for
+ * PETSc matrices.
*
* Note that Trilinos stores the elements within each row in ascending
* order. This is opposed to the deal.II sparse matrix style where the
diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h
index ac0f948d79..aadeadea85 100644
--- a/include/deal.II/lac/trilinos_sparsity_pattern.h
+++ b/include/deal.II/lac/trilinos_sparsity_pattern.h
@@ -968,7 +968,7 @@ namespace TrilinosWrappers
//@{
/**
- * STL-like iterator with the first entry.
+ * Iterator starting at the first entry.
*/
const_iterator begin () const;
@@ -978,7 +978,7 @@ namespace TrilinosWrappers
const_iterator end () const;
/**
- * STL-like iterator with the first entry of row @p r.
+ * Iterator starting at the first entry of row @p r.
*
* Note that if the given row is empty, i.e. does not contain any nonzero
* entries, then the iterator returned by this function equals
diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h
index 304cdc0d33..21de7dc933 100644
--- a/include/deal.II/lac/vector.h
+++ b/include/deal.II/lac/vector.h
@@ -159,8 +159,8 @@ public:
* Copy-constructor. Sets the dimension to that of the given vector, and
* copies all elements.
*
- * We would like to make this constructor explicit, but STL insists on using
- * it implicitly.
+ * We would like to make this constructor explicit, but standard containers
+ * insist on using it implicitly.
*/
Vector (const Vector &v);
@@ -273,8 +273,8 @@ public:
* waste some memory, so keep this in mind. However, if N==0 all
* memory is freed, i.e. if you want to resize the vector and release the
* memory not needed, you have to first call reinit(0) and then
- * reinit(N). This cited behaviour is analogous to that of the STL
- * containers.
+ * reinit(N). This cited behaviour is analogous to that of the
+ * standard library containers.
*
* If @p fast is false, the vector is filled by zeros. Otherwise, the
* elements are left an unspecified state.
diff --git a/source/grid/grid_refinement.cc b/source/grid/grid_refinement.cc
index ad8da22f61..3282956d50 100644
--- a/source/grid/grid_refinement.cc
+++ b/source/grid/grid_refinement.cc
@@ -167,13 +167,9 @@ namespace
namespace
{
/**
- * Sorts the vector @p ind as an
- * index vector of @p a in
- * increasing order. This
- * implementation of quicksort
- * seems to be faster than the
- * STL version and is needed in
- * @p refine_and_coarsen_optimize
+ * Sorts the vector @p ind as an index vector of @p a in increasing order.
+ * This implementation of quicksort seems to be faster than the standard
+ * library version and is needed in @p refine_and_coarsen_optimize.
*/
template
--
2.39.5