]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use typename BlockMatrixType in templates.
authorDavid Wells <wellsd2@rpi.edu>
Mon, 19 Oct 2015 02:27:59 +0000 (22:27 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Mon, 2 Nov 2015 16:21:25 +0000 (11:21 -0500)
This replaces the use of 'BlockMatrix', which, while it is not a class
name, looks a lot like one.

include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_matrix_base.h

index 5297cc68f2800cc7a5cb49ad61dc75e279f89638..567a0e788d62f7f206b3f32bf524128fd2e9295a 100644 (file)
@@ -35,9 +35,9 @@ class BlockLinearOperator;
 
 template <typename Range = BlockVector<double>,
           typename Domain = Range,
-          typename BlockMatrix>
+          typename BlockMatrixType>
 BlockLinearOperator<Range, Domain>
-block_operator(const BlockMatrix &matrix);
+block_operator(const BlockMatrixType &matrix);
 
 template <size_t m, size_t n,
           typename Range = BlockVector<double>,
@@ -66,9 +66,9 @@ block_diagonal_operator(const LinearOperator<typename Range::BlockType, typename
 
 template <typename Range = BlockVector<double>,
           typename Domain = Range,
-          typename BlockMatrix>
+          typename BlockMatrixType>
 BlockLinearOperator<Range, Domain>
-block_diagonal_operator(const BlockMatrix &block_matrix);
+block_diagonal_operator(const BlockMatrixType &block_matrix);
 
 template <typename Range = BlockVector<double>,
           typename Domain = Range>
@@ -388,9 +388,9 @@ namespace internal
  */
 template <typename Range,
           typename Domain,
-          typename BlockMatrix>
+          typename BlockMatrixType>
 BlockLinearOperator<Range, Domain>
-block_operator(const BlockMatrix &block_matrix)
+block_operator(const BlockMatrixType &block_matrix)
 {
   typedef typename BlockLinearOperator<Range, Domain>::BlockType BlockType;
 
@@ -502,9 +502,9 @@ block_operator(const std::array<std::array<LinearOperator<typename Range::BlockT
  */
 template <typename Range,
           typename Domain,
-          typename BlockMatrix>
+          typename BlockMatrixType>
 BlockLinearOperator<Range, Domain>
-block_diagonal_operator(const BlockMatrix &block_matrix)
+block_diagonal_operator(const BlockMatrixType &block_matrix)
 {
   typedef typename BlockLinearOperator<Range, Domain>::BlockType BlockType;
 
index 080cb654b2ca75d3704af2f67fbad934fdbc93a5..18cf56f80fd087538ef3ca2b0392f941780ca709 100644 (file)
@@ -53,7 +53,7 @@ namespace BlockMatrixIterators
    * Base class for block matrix accessors, implementing the stepping through
    * a matrix.
    */
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   class AccessorBase
   {
   public:
@@ -65,7 +65,7 @@ namespace BlockMatrixIterators
     /**
      * Typedef the value type of the matrix we point into.
      */
-    typedef typename BlockMatrix::value_type value_type;
+    typedef typename BlockMatrixType::value_type value_type;
 
     /**
      * Initialize data fields to default values.
@@ -105,17 +105,17 @@ namespace BlockMatrixIterators
   /**
    * Accessor classes in block matrices.
    */
-  template <class BlockMatrix, bool ConstNess>
+  template <class BlockMatrixType, bool Constness>
   class Accessor;
 
 
   /**
    * Block matrix accessor for non const matrices.
    */
-  template <class BlockMatrix>
-  class Accessor<BlockMatrix, false>
+  template <class BlockMatrixType>
+  class Accessor<BlockMatrixType, false>
     :
-    public AccessorBase<BlockMatrix>
+    public AccessorBase<BlockMatrixType>
   {
   public:
     /**
@@ -126,12 +126,12 @@ namespace BlockMatrixIterators
     /**
      * Type of the matrix used in this accessor.
      */
-    typedef BlockMatrix MatrixType;
+    typedef BlockMatrixType MatrixType;
 
     /**
      * Typedef the value type of the matrix we point into.
      */
-    typedef typename BlockMatrix::value_type value_type;
+    typedef typename BlockMatrixType::value_type value_type;
 
     /**
      * Constructor. Since we use accessors only for read access, a const
@@ -141,7 +141,7 @@ namespace BlockMatrixIterators
      * create the end pointer if @p row equals the total number of rows in the
      * matrix.
      */
-    Accessor (BlockMatrix *m,
+    Accessor (BlockMatrixType *m,
               const size_type row,
               const size_type col);
 
@@ -169,12 +169,12 @@ namespace BlockMatrixIterators
     /**
      * The matrix accessed.
      */
-    BlockMatrix *matrix;
+    BlockMatrixType *matrix;
 
     /**
      * Iterator of the underlying matrix class.
      */
-    typename BlockMatrix::BlockType::iterator base_iterator;
+    typename BlockMatrixType::BlockType::iterator base_iterator;
 
     /**
      * Move ahead one element.
@@ -187,17 +187,17 @@ namespace BlockMatrixIterators
     bool operator == (const Accessor &a) const;
 
     template <typename> friend class MatrixIterator;
-    friend class Accessor<BlockMatrix, true>;
+    friend class Accessor<BlockMatrixType, true>;
   };
 
   /**
    * Block matrix accessor for constant matrices, implementing the stepping
    * through a matrix.
    */
-  template <class BlockMatrix>
-  class Accessor<BlockMatrix, true>
+  template <class BlockMatrixType>
+  class Accessor<BlockMatrixType, true>
     :
-    public AccessorBase<BlockMatrix>
+    public AccessorBase<BlockMatrixType>
   {
   public:
     /**
@@ -208,12 +208,12 @@ namespace BlockMatrixIterators
     /**
      * Type of the matrix used in this accessor.
      */
-    typedef const BlockMatrix MatrixType;
+    typedef const BlockMatrixType MatrixType;
 
     /**
      * Typedef the value type of the matrix we point into.
      */
-    typedef typename BlockMatrix::value_type value_type;
+    typedef typename BlockMatrixType::value_type value_type;
 
     /**
      * Constructor. Since we use accessors only for read access, a const
@@ -223,14 +223,14 @@ namespace BlockMatrixIterators
      * create the end pointer if @p row equals the total number of rows in the
      * matrix.
      */
-    Accessor (const BlockMatrix *m,
+    Accessor (const BlockMatrixType *m,
               const size_type row,
               const size_type col);
 
     /**
      * Initialize const accessor from non const accessor.
      */
-    Accessor(const Accessor<BlockMatrix, false> &);
+    Accessor(const Accessor<BlockMatrixType, false> &);
 
     /**
      * Row number of the element represented by this object.
@@ -250,12 +250,12 @@ namespace BlockMatrixIterators
     /**
      * The matrix accessed.
      */
-    const BlockMatrix *matrix;
+    const BlockMatrixType *matrix;
 
     /**
      * Iterator of the underlying matrix class.
      */
-    typename BlockMatrix::BlockType::const_iterator base_iterator;
+    typename BlockMatrixType::BlockType::const_iterator base_iterator;
 
     /**
      * Move ahead one element.
@@ -1040,19 +1040,19 @@ private:
 
 namespace BlockMatrixIterators
 {
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  AccessorBase<BlockMatrix>::AccessorBase()
+  AccessorBase<BlockMatrixType>::AccessorBase()
     :
     row_block(0),
     col_block(0)
   {}
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   unsigned int
-  AccessorBase<BlockMatrix>::block_row() const
+  AccessorBase<BlockMatrixType>::block_row() const
   {
     Assert (row_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1061,10 +1061,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   unsigned int
-  AccessorBase<BlockMatrix>::block_column() const
+  AccessorBase<BlockMatrixType>::block_column() const
   {
     Assert (col_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1073,12 +1073,12 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  Accessor<BlockMatrix, true>::Accessor (
-    const BlockMatrix  *matrix,
-    const size_type     row,
-    const size_type     col)
+  Accessor<BlockMatrixType, true>::Accessor (
+    const BlockMatrixType  *matrix,
+    const size_type        row,
+    const size_type        col)
     :
     matrix(matrix),
     base_iterator(matrix->block(0,0).begin())
@@ -1126,9 +1126,9 @@ namespace BlockMatrixIterators
   }
 
 
-//   template <class BlockMatrix>
+//   template <class BlockMatrixType>
 //   inline
-//   Accessor<BlockMatrix, true>::Accessor (const Accessor<BlockMatrix, true>& other)
+//   Accessor<BlockMatrixType, true>::Accessor (const Accessor<BlockMatrixType, true>& other)
 //                :
 //                matrix(other.matrix),
 //                base_iterator(other.base_iterator)
@@ -1138,9 +1138,9 @@ namespace BlockMatrixIterators
 //   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  Accessor<BlockMatrix, true>::Accessor (const Accessor<BlockMatrix, false> &other)
+  Accessor<BlockMatrixType, true>::Accessor (const Accessor<BlockMatrixType, false> &other)
     :
     matrix(other.matrix),
     base_iterator(other.base_iterator)
@@ -1150,10 +1150,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, true>::size_type
-  Accessor<BlockMatrix, true>::row() const
+  typename Accessor<BlockMatrixType, true>::size_type
+  Accessor<BlockMatrixType, true>::row() const
   {
     Assert (this->row_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1163,10 +1163,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, true>::size_type
-  Accessor<BlockMatrix, true>::column() const
+  typename Accessor<BlockMatrixType, true>::size_type
+  Accessor<BlockMatrixType, true>::column() const
   {
     Assert (this->col_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1176,10 +1176,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, true>::value_type
-  Accessor<BlockMatrix, true>::value () const
+  typename Accessor<BlockMatrixType, true>::value_type
+  Accessor<BlockMatrixType, true>::value () const
   {
     Assert (this->row_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1191,10 +1191,10 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   void
-  Accessor<BlockMatrix, true>::advance ()
+  Accessor<BlockMatrixType, true>::advance ()
   {
     Assert (this->row_block != numbers::invalid_unsigned_int,
             ExcIteratorPastEnd());
@@ -1257,10 +1257,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   bool
-  Accessor<BlockMatrix, true>::operator == (const Accessor &a) const
+  Accessor<BlockMatrixType, true>::operator == (const Accessor &a) const
   {
     if (matrix != a.matrix)
       return false;
@@ -1283,12 +1283,12 @@ namespace BlockMatrixIterators
 //----------------------------------------------------------------------//
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  Accessor<BlockMatrix, false>::Accessor (
-    BlockMatrix  *matrix,
-    const size_type row,
-    const size_type col)
+  Accessor<BlockMatrixType, false>::Accessor (
+    BlockMatrixType  *matrix,
+    const size_type  row,
+    const size_type  col)
     :
     matrix(matrix),
     base_iterator(matrix->block(0,0).begin())
@@ -1335,10 +1335,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, false>::size_type
-  Accessor<BlockMatrix, false>::row() const
+  typename Accessor<BlockMatrixType, false>::size_type
+  Accessor<BlockMatrixType, false>::row() const
   {
     Assert (this->row_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1348,10 +1348,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, false>::size_type
-  Accessor<BlockMatrix, false>::column() const
+  typename Accessor<BlockMatrixType, false>::size_type
+  Accessor<BlockMatrixType, false>::column() const
   {
     Assert (this->col_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1361,10 +1361,10 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
-  typename Accessor<BlockMatrix, false>::value_type
-  Accessor<BlockMatrix, false>::value () const
+  typename Accessor<BlockMatrixType, false>::value_type
+  Accessor<BlockMatrixType, false>::value () const
   {
     Assert (this->row_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1376,10 +1376,10 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   void
-  Accessor<BlockMatrix, false>::set_value (typename Accessor<BlockMatrix, false>::value_type newval) const
+  Accessor<BlockMatrixType, false>::set_value (typename Accessor<BlockMatrixType, false>::value_type newval) const
   {
     Assert (this->row_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1391,10 +1391,10 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   void
-  Accessor<BlockMatrix, false>::advance ()
+  Accessor<BlockMatrixType, false>::advance ()
   {
     Assert (this->row_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1458,10 +1458,10 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrix>
+  template <class BlockMatrixType>
   inline
   bool
-  Accessor<BlockMatrix, false>::operator == (const Accessor &a) const
+  Accessor<BlockMatrixType, false>::operator == (const Accessor &a) const
   {
     if (matrix != a.matrix)
       return false;

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.