]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename private variables; fix changes.h entry 1780/head
authorMatthias Maier <tamiko@43-1.org>
Fri, 23 Oct 2015 19:50:49 +0000 (14:50 -0500)
committerMatthias Maier <tamiko@43-1.org>
Fri, 23 Oct 2015 19:51:22 +0000 (14:51 -0500)
This commit renames some private variables intrdocued in pull request #1673
to fit our naming rules.

Further, fix some issues with the doxygen documentation.

doc/news/changes.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/precondition.h

index 3edcdc60fb0c358288da66ea21c924f81cf61de5..54eb17eef03ca036efdfbd089cc9fd8542d80b35 100644 (file)
@@ -170,13 +170,15 @@ inconvenience this causes.
   (Timo Heister, 2015/09/30)
   </li>
 
-  <li> 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 .
+  <li> 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
+  <code>tests/lac/linear_operator_08.cc</code>.
   <br>
   (Jean-Paul Pelteret, 2015/09/24 - 2015/10/19)
   </li>
@@ -383,9 +385,9 @@ inconvenience this causes.
   (Alberto Sartori, 2015/10/22)
   </li>
 
-  <li> 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.
+  <li> 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.
   <br>
   (Jean-Paul Pelteret, 2015/10/19)
   </li>
index 4b27ee6bcb5af63cbf4ecfd8b3533529974213d0..aad96c0253658657b315198f21a78ce977fe40cd 100644 (file)
@@ -232,7 +232,7 @@ private:
   /**
    * The pointer to the actual matrix.
    */
-  SmartPointer<const MATRIX,PointerMatrix<MATRIX,VECTOR> > mtrx;
+  SmartPointer<const MATRIX,PointerMatrix<MATRIX,VECTOR> > matrix;
 };
 
 
@@ -376,7 +376,7 @@ private:
   /**
    * The pointer to the actual matrix.
    */
-  SmartPointer<const MATRIX,PointerMatrixAux<MATRIX,VECTOR> > mtrx;
+  SmartPointer<const MATRIX,PointerMatrixAux<MATRIX,VECTOR> > matrix;
 };
 
 
@@ -511,7 +511,7 @@ private:
   /**
    * The pointer to the actual matrix.
    */
-  SmartPointer<const Vector<number>,PointerMatrixVector<number> > mtrx;
+  SmartPointer<const Vector<number>,PointerMatrixVector<number> > matrix;
 };
 
 
@@ -674,13 +674,13 @@ PointerMatrixBase<VECTOR>::~PointerMatrixBase ()
 
 template<class MATRIX, class VECTOR>
 PointerMatrix<MATRIX, VECTOR>::PointerMatrix (const MATRIX *M)
-  : mtrx(M, typeid(*this).name())
+  : matrix(M, typeid(*this).name())
 {}
 
 
 template<class MATRIX, class VECTOR>
 PointerMatrix<MATRIX, VECTOR>::PointerMatrix (const char *name)
-  : mtrx(0, name)
+  : matrix(0, name)
 {}
 
 
@@ -688,7 +688,7 @@ template<class MATRIX, class VECTOR>
 PointerMatrix<MATRIX, VECTOR>::PointerMatrix (
   const MATRIX *M,
   const char *name)
-  : mtrx(M, name)
+  : matrix(M, name)
 {}
 
 
@@ -696,7 +696,7 @@ template<class MATRIX, class VECTOR>
 inline void
 PointerMatrix<MATRIX, VECTOR>::clear ()
 {
-  mtrx = 0;
+  matrix = 0;
 }
 
 
@@ -704,7 +704,7 @@ template<class MATRIX, class VECTOR>
 inline const PointerMatrix<MATRIX, VECTOR> &
 PointerMatrix<MATRIX, VECTOR>::operator= (const MATRIX *M)
 {
-  mtrx = M;
+  matrix = M;
   return *this;
 }
 
@@ -713,9 +713,9 @@ template<class MATRIX, class VECTOR>
 inline bool
 PointerMatrix<MATRIX, VECTOR>::empty () const
 {
-  if (mtrx == 0)
+  if (matrix == 0)
     return true;
-  return mtrx->empty();
+  return matrix->empty();
 }
 
 template<class MATRIX, class VECTOR>
@@ -723,8 +723,8 @@ inline void
 PointerMatrix<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<class MATRIX, class VECTOR>
 inline typename PointerMatrix<MATRIX, VECTOR>::size_type
 PointerMatrix<MATRIX, VECTOR>::m () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->m();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->m();
 }
 
 
@@ -771,8 +771,8 @@ template<class MATRIX, class VECTOR>
 inline typename PointerMatrix<MATRIX, VECTOR>::size_type
 PointerMatrix<MATRIX, VECTOR>::n () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->n();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->n();
 }
 
 
@@ -784,7 +784,7 @@ PointerMatrixAux<MATRIX, VECTOR>::PointerMatrixAux (
   VectorMemory<VECTOR> *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<MATRIX, VECTOR>::PointerMatrixAux (
   VectorMemory<VECTOR> *mem,
   const char *name)
   : mem(mem, name),
-    mtrx(0, name)
+    matrix(0, name)
 {
   if (mem == 0) mem = &my_memory;
 }
@@ -807,7 +807,7 @@ PointerMatrixAux<MATRIX, VECTOR>::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<class MATRIX, class VECTOR>
 inline void
 PointerMatrixAux<MATRIX, VECTOR>::clear ()
 {
-  mtrx = 0;
+  matrix = 0;
 }
 
 
@@ -825,7 +825,7 @@ template<class MATRIX, class VECTOR>
 inline const PointerMatrixAux<MATRIX, VECTOR> &
 PointerMatrixAux<MATRIX, VECTOR>::operator= (const MATRIX *M)
 {
-  mtrx = M;
+  matrix = M;
   return *this;
 }
 
@@ -844,9 +844,9 @@ template<class MATRIX, class VECTOR>
 inline bool
 PointerMatrixAux<MATRIX, VECTOR>::empty () const
 {
-  if (mtrx == 0)
+  if (matrix == 0)
     return true;
-  return mtrx->empty();
+  return matrix->empty();
 }
 
 template<class MATRIX, class VECTOR>
@@ -857,8 +857,8 @@ PointerMatrixAux<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<MATRIX, VECTOR>::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<class MATRIX, class VECTOR>
 inline typename PointerMatrixAux<MATRIX, VECTOR>::size_type
 PointerMatrixAux<MATRIX, VECTOR>::m () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->m();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->m();
 }
 
 
@@ -922,8 +922,8 @@ template<class MATRIX, class VECTOR>
 inline typename PointerMatrixAux<MATRIX, VECTOR>::size_type
 PointerMatrixAux<MATRIX, VECTOR>::n () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->n();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->n();
 }
 
 
@@ -932,13 +932,13 @@ PointerMatrixAux<MATRIX, VECTOR>::n () const
 
 template<typename number>
 PointerMatrixVector<number>::PointerMatrixVector (const Vector<number> *M)
-  : mtrx(M, typeid(*this).name())
+  : matrix(M, typeid(*this).name())
 {}
 
 
 template<typename number>
 PointerMatrixVector<number>::PointerMatrixVector (const char *name)
-  : mtrx(0, name)
+  : matrix(0, name)
 {}
 
 
@@ -946,7 +946,7 @@ template<typename number>
 PointerMatrixVector<number>::PointerMatrixVector (
   const Vector<number> *M,
   const char *name)
-  : mtrx(M, name)
+  : matrix(M, name)
 {}
 
 
@@ -954,7 +954,7 @@ template<typename number>
 inline void
 PointerMatrixVector<number>::clear ()
 {
-  mtrx = 0;
+  matrix = 0;
 }
 
 
@@ -962,7 +962,7 @@ template<typename number>
 inline const PointerMatrixVector<number> &
 PointerMatrixVector<number>::operator= (const Vector<number> *M)
 {
-  mtrx = M;
+  matrix = M;
   return *this;
 }
 
@@ -971,9 +971,9 @@ template<typename number>
 inline bool
 PointerMatrixVector<number>::empty () const
 {
-  if (mtrx == 0)
+  if (matrix == 0)
     return true;
-  return mtrx->empty();
+  return matrix->empty();
 }
 
 template<typename number>
@@ -982,10 +982,10 @@ PointerMatrixVector<number>::vmult (
   Vector<number> &dst,
   const Vector<number> &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<number>::Tvmult (
   Vector<number> &dst,
   const Vector<number> &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<number>::vmult_add (
   Vector<number> &dst,
   const Vector<number> &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<number>::Tvmult_add (
   Vector<number> &dst,
   const Vector<number> &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<typename number>
 inline typename PointerMatrixVector<number>::size_type
 PointerMatrixVector<number>::m () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->m();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->m();
 }
 
 
@@ -1041,8 +1041,8 @@ template<typename number>
 inline typename PointerMatrixVector<number>::size_type
 PointerMatrixVector<number>::n () const
 {
-  Assert (mtrx != 0, ExcNotInitialized());
-  return mtrx->n();
+  Assert (matrix != 0, ExcNotInitialized());
+  return matrix->n();
 }
 
 
index 246af14d9cd928e9c4c906ed6a6735e7b0f5b805..9950fba5a782b3acf2b03eef0d2ea53dc9858315 100644 (file)
@@ -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 <class MATRIX>
@@ -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 &parameters)
 {
   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;
 }
 
 //---------------------------------------------------------------------------

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.