From: Matthias Maier Date: Fri, 23 Oct 2015 19:50:49 +0000 (-0500) Subject: Rename private variables; fix changes.h entry X-Git-Tag: v8.4.0-rc2~292^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F1780%2Fhead;p=dealii.git Rename private variables; fix changes.h entry This commit renames some private variables intrdocued in pull request #1673 to fit our naming rules. Further, fix some issues with the doxygen documentation. --- diff --git a/doc/news/changes.h b/doc/news/changes.h index 3edcdc60fb..54eb17eef0 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -170,13 +170,15 @@ inconvenience this causes. (Timo Heister, 2015/09/30) -
  • Improved: The interface to all deal.II type solvers and preconditioners have - been updated such that they function as expected with the LinearOperator class and - its associated functions (i.e. linear_operator, transpose_operator and - inverse_operator). These preconditioners can now be wrapped as a LinearOperator, - facilitating the construction of approximate matrix inverses such as in the - development of a block matrix preconditioner. - An example of this functionality can be found in tests/lac/linear_operator_08.cc . +
  • Improved: The interface to all deal.II type solvers and + preconditioners have been updated such that they function as expected + with the LinearOperator class and its associated functions (i.e. + linear_operator(), transpose_operator() and inverse_operator()). + These preconditioners can now be wrapped as a LinearOperator, + facilitating the construction of approximate matrix inverses such as in + the development of a block matrix preconditioner. An example of this + functionality can be found in + tests/lac/linear_operator_08.cc.
    (Jean-Paul Pelteret, 2015/09/24 - 2015/10/19)
  • @@ -383,9 +385,9 @@ inconvenience this causes. (Alberto Sartori, 2015/10/22) -
  • Fixed: The range vectors in the construction of an inverse_operator - is now reinitialised before solve calls. This ensures a consistent starting - point for the solver. +
  • Fixed: The range vectors in the construction of an + inverse_operator() is now reinitialised before solve calls. This ensures + a consistent starting point for the solver.
    (Jean-Paul Pelteret, 2015/10/19)
  • diff --git a/include/deal.II/lac/pointer_matrix.h b/include/deal.II/lac/pointer_matrix.h index 4b27ee6bcb..aad96c0253 100644 --- a/include/deal.II/lac/pointer_matrix.h +++ b/include/deal.II/lac/pointer_matrix.h @@ -232,7 +232,7 @@ private: /** * The pointer to the actual matrix. */ - SmartPointer > mtrx; + SmartPointer > matrix; }; @@ -376,7 +376,7 @@ private: /** * The pointer to the actual matrix. */ - SmartPointer > mtrx; + SmartPointer > matrix; }; @@ -511,7 +511,7 @@ private: /** * The pointer to the actual matrix. */ - SmartPointer,PointerMatrixVector > mtrx; + SmartPointer,PointerMatrixVector > matrix; }; @@ -674,13 +674,13 @@ PointerMatrixBase::~PointerMatrixBase () template PointerMatrix::PointerMatrix (const MATRIX *M) - : mtrx(M, typeid(*this).name()) + : matrix(M, typeid(*this).name()) {} template PointerMatrix::PointerMatrix (const char *name) - : mtrx(0, name) + : matrix(0, name) {} @@ -688,7 +688,7 @@ template PointerMatrix::PointerMatrix ( const MATRIX *M, const char *name) - : mtrx(M, name) + : matrix(M, name) {} @@ -696,7 +696,7 @@ template inline void PointerMatrix::clear () { - mtrx = 0; + matrix = 0; } @@ -704,7 +704,7 @@ template inline const PointerMatrix & PointerMatrix::operator= (const MATRIX *M) { - mtrx = M; + matrix = M; return *this; } @@ -713,9 +713,9 @@ template inline bool PointerMatrix::empty () const { - if (mtrx == 0) + if (matrix == 0) return true; - return mtrx->empty(); + return matrix->empty(); } template @@ -723,8 +723,8 @@ inline void PointerMatrix::vmult (VECTOR &dst, const VECTOR &src) const { - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->vmult (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->vmult (dst, src); } @@ -733,8 +733,8 @@ inline void PointerMatrix::Tvmult (VECTOR &dst, const VECTOR &src) const { - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->Tvmult (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->Tvmult (dst, src); } @@ -743,8 +743,8 @@ inline void PointerMatrix::vmult_add (VECTOR &dst, const VECTOR &src) const { - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->vmult_add (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->vmult_add (dst, src); } @@ -753,8 +753,8 @@ inline void PointerMatrix::Tvmult_add (VECTOR &dst, const VECTOR &src) const { - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->Tvmult_add (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->Tvmult_add (dst, src); } @@ -762,8 +762,8 @@ template inline typename PointerMatrix::size_type PointerMatrix::m () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->m(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->m(); } @@ -771,8 +771,8 @@ template inline typename PointerMatrix::size_type PointerMatrix::n () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->n(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->n(); } @@ -784,7 +784,7 @@ PointerMatrixAux::PointerMatrixAux ( VectorMemory *mem, const MATRIX *M) : mem(mem, typeid(*this).name()), - mtrx(M, typeid(*this).name()) + matrix(M, typeid(*this).name()) { if (mem == 0) mem = &my_memory; } @@ -795,7 +795,7 @@ PointerMatrixAux::PointerMatrixAux ( VectorMemory *mem, const char *name) : mem(mem, name), - mtrx(0, name) + matrix(0, name) { if (mem == 0) mem = &my_memory; } @@ -807,7 +807,7 @@ PointerMatrixAux::PointerMatrixAux ( const MATRIX *M, const char *name) : mem(mem, name), - mtrx(M, name) + matrix(M, name) { if (mem == 0) mem = &my_memory; } @@ -817,7 +817,7 @@ template inline void PointerMatrixAux::clear () { - mtrx = 0; + matrix = 0; } @@ -825,7 +825,7 @@ template inline const PointerMatrixAux & PointerMatrixAux::operator= (const MATRIX *M) { - mtrx = M; + matrix = M; return *this; } @@ -844,9 +844,9 @@ template inline bool PointerMatrixAux::empty () const { - if (mtrx == 0) + if (matrix == 0) return true; - return mtrx->empty(); + return matrix->empty(); } template @@ -857,8 +857,8 @@ PointerMatrixAux::vmult (VECTOR &dst, if (mem == 0) mem = &my_memory; Assert (mem != 0, ExcNotInitialized()); - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->vmult (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->vmult (dst, src); } @@ -870,8 +870,8 @@ PointerMatrixAux::Tvmult (VECTOR &dst, if (mem == 0) mem = &my_memory; Assert (mem != 0, ExcNotInitialized()); - Assert (mtrx != 0, ExcNotInitialized()); - mtrx->Tvmult (dst, src); + Assert (matrix != 0, ExcNotInitialized()); + matrix->Tvmult (dst, src); } @@ -883,10 +883,10 @@ PointerMatrixAux::vmult_add (VECTOR &dst, if (mem == 0) mem = &my_memory; Assert (mem != 0, ExcNotInitialized()); - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); VECTOR *v = mem->alloc(); v->reinit(dst); - mtrx->vmult (*v, src); + matrix->vmult (*v, src); dst += *v; mem->free(v); } @@ -900,10 +900,10 @@ PointerMatrixAux::Tvmult_add (VECTOR &dst, if (mem == 0) mem = &my_memory; Assert (mem != 0, ExcNotInitialized()); - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); VECTOR *v = mem->alloc(); v->reinit(dst); - mtrx->Tvmult (*v, src); + matrix->Tvmult (*v, src); dst += *v; mem->free(v); } @@ -913,8 +913,8 @@ template inline typename PointerMatrixAux::size_type PointerMatrixAux::m () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->m(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->m(); } @@ -922,8 +922,8 @@ template inline typename PointerMatrixAux::size_type PointerMatrixAux::n () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->n(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->n(); } @@ -932,13 +932,13 @@ PointerMatrixAux::n () const template PointerMatrixVector::PointerMatrixVector (const Vector *M) - : mtrx(M, typeid(*this).name()) + : matrix(M, typeid(*this).name()) {} template PointerMatrixVector::PointerMatrixVector (const char *name) - : mtrx(0, name) + : matrix(0, name) {} @@ -946,7 +946,7 @@ template PointerMatrixVector::PointerMatrixVector ( const Vector *M, const char *name) - : mtrx(M, name) + : matrix(M, name) {} @@ -954,7 +954,7 @@ template inline void PointerMatrixVector::clear () { - mtrx = 0; + matrix = 0; } @@ -962,7 +962,7 @@ template inline const PointerMatrixVector & PointerMatrixVector::operator= (const Vector *M) { - mtrx = M; + matrix = M; return *this; } @@ -971,9 +971,9 @@ template inline bool PointerMatrixVector::empty () const { - if (mtrx == 0) + if (matrix == 0) return true; - return mtrx->empty(); + return matrix->empty(); } template @@ -982,10 +982,10 @@ PointerMatrixVector::vmult ( Vector &dst, const Vector &src) const { - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); Assert (dst.size() == 1, ExcDimensionMismatch(dst.size(), 1)); - dst(0) = *mtrx * src; + dst(0) = *matrix * src; } @@ -995,10 +995,10 @@ PointerMatrixVector::Tvmult ( Vector &dst, const Vector &src) const { - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); Assert(src.size() == 1, ExcDimensionMismatch(src.size(), 1)); - dst.equ (src(0), *mtrx); + dst.equ (src(0), *matrix); } @@ -1008,10 +1008,10 @@ PointerMatrixVector::vmult_add ( Vector &dst, const Vector &src) const { - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); Assert (dst.size() == 1, ExcDimensionMismatch(dst.size(), 1)); - dst(0) += *mtrx * src; + dst(0) += *matrix * src; } @@ -1021,10 +1021,10 @@ PointerMatrixVector::Tvmult_add ( Vector &dst, const Vector &src) const { - Assert (mtrx != 0, ExcNotInitialized()); + Assert (matrix != 0, ExcNotInitialized()); Assert(src.size() == 1, ExcDimensionMismatch(src.size(), 1)); - dst.add (src(0), *mtrx); + dst.add (src(0), *matrix); } @@ -1032,8 +1032,8 @@ template inline typename PointerMatrixVector::size_type PointerMatrixVector::m () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->m(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->m(); } @@ -1041,8 +1041,8 @@ template inline typename PointerMatrixVector::size_type PointerMatrixVector::n () const { - Assert (mtrx != 0, ExcNotInitialized()); - return mtrx->n(); + Assert (matrix != 0, ExcNotInitialized()); + return matrix->n(); } diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index 246af14d9c..9950fba5a7 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -156,12 +156,12 @@ private: /** * The dimension of the range space. */ - size_type _m; + size_type n_rows; /** * The dimension of the domain space. */ - size_type _n; + size_type n_columns; }; @@ -283,12 +283,12 @@ private: /** * The dimension of the range space. */ - size_type _m; + size_type n_rows; /** * The dimension of the domain space. */ - size_type _n; + size_type n_columns; }; @@ -982,8 +982,8 @@ private: inline PreconditionIdentity::PreconditionIdentity () : - _m (0), - _n (0) + n_rows (0), + n_columns (0) {} template @@ -992,8 +992,8 @@ PreconditionIdentity::initialize ( const MATRIX &matrix, const PreconditionIdentity::AdditionalData &) { - _m = matrix.m(); - _n = matrix.n(); + n_rows = matrix.m(); + n_columns = matrix.n(); } @@ -1032,15 +1032,15 @@ PreconditionIdentity::Tvmult_add (VECTOR &dst, const VECTOR &src) const inline typename PreconditionIdentity::size_type PreconditionIdentity::m () const { - Assert(_m != 0, ExcNotInitialized()); - return _m; + Assert(n_rows != 0, ExcNotInitialized()); + return n_rows; } inline typename PreconditionIdentity::size_type PreconditionIdentity::n () const { - Assert(_n != 0, ExcNotInitialized()); - return _n; + Assert(n_columns != 0, ExcNotInitialized()); + return n_columns; } //--------------------------------------------------------------------------- @@ -1057,8 +1057,8 @@ inline PreconditionRichardson::PreconditionRichardson () : relaxation(0), - _m (0), - _n (0) + n_rows (0), + n_columns (0) { AdditionalData add_data; relaxation=add_data.relaxation; @@ -1082,8 +1082,8 @@ PreconditionRichardson::initialize ( const PreconditionRichardson::AdditionalData ¶meters) { relaxation = parameters.relaxation; - _m = matrix.m(); - _n = matrix.n(); + n_rows = matrix.m(); + n_columns = matrix.n(); } @@ -1123,15 +1123,15 @@ PreconditionRichardson::Tvmult_add (VECTOR &dst, const VECTOR &src) const inline typename PreconditionRichardson::size_type PreconditionRichardson::m () const { - Assert(_m != 0, ExcNotInitialized()); - return _m; + Assert(n_rows != 0, ExcNotInitialized()); + return n_rows; } inline typename PreconditionRichardson::size_type PreconditionRichardson::n () const { - Assert(_n != 0, ExcNotInitialized()); - return _n; + Assert(n_columns != 0, ExcNotInitialized()); + return n_columns; } //---------------------------------------------------------------------------