]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Change typedef std::size_t size_type to typedef types::global_dof_index size_type...
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 19 Feb 2013 21:40:41 +0000 (21:40 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 19 Feb 2013 21:40:41 +0000 (21:40 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28480 0785d39b-7218-0410-832d-ea1e28bc413d

53 files changed:
deal.II/include/deal.II/base/types.h
deal.II/include/deal.II/lac/arpack_solver.h
deal.II/include/deal.II/lac/block_indices.h
deal.II/include/deal.II/lac/block_list.h
deal.II/include/deal.II/lac/block_matrix_array.h
deal.II/include/deal.II/lac/block_matrix_base.h
deal.II/include/deal.II/lac/block_sparse_matrix.h
deal.II/include/deal.II/lac/block_sparse_matrix.templates.h
deal.II/include/deal.II/lac/block_sparse_matrix_ez.h
deal.II/include/deal.II/lac/block_sparsity_pattern.h
deal.II/include/deal.II/lac/block_vector.h
deal.II/include/deal.II/lac/block_vector.templates.h
deal.II/include/deal.II/lac/block_vector_base.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h
deal.II/include/deal.II/lac/chunk_sparsity_pattern.h
deal.II/include/deal.II/lac/compressed_set_sparsity_pattern.h
deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h
deal.II/include/deal.II/lac/compressed_sparsity_pattern.h
deal.II/include/deal.II/lac/constraint_matrix.h
deal.II/include/deal.II/lac/constraint_matrix.templates.h
deal.II/include/deal.II/lac/eigen.h
deal.II/include/deal.II/lac/filtered_matrix.h
deal.II/include/deal.II/lac/full_matrix.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/petsc_vector_base.h
deal.II/include/deal.II/lac/tridiagonal_matrix.h
deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_block_vector.h
deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h
deal.II/include/deal.II/lac/trilinos_precondition.h
deal.II/include/deal.II/lac/trilinos_sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/include/deal.II/lac/vector_memory.h
deal.II/include/deal.II/lac/vector_view.h
deal.II/include/deal.II/matrix_free/dof_info.templates.h
deal.II/source/lac/block_matrix_array.cc
deal.II/source/lac/block_sparsity_pattern.cc
deal.II/source/lac/chunk_sparsity_pattern.cc
deal.II/source/lac/compressed_set_sparsity_pattern.cc
deal.II/source/lac/compressed_simple_sparsity_pattern.cc
deal.II/source/lac/compressed_sparsity_pattern.cc
deal.II/source/lac/constraint_matrix.cc
deal.II/source/lac/trilinos_block_sparse_matrix.cc
deal.II/source/lac/trilinos_precondition.cc
deal.II/source/lac/trilinos_sparse_matrix.cc
deal.II/source/lac/trilinos_sparsity_pattern.cc
deal.II/source/lac/trilinos_vector.cc
deal.II/source/lac/trilinos_vector_base.cc

index f5be470f6fe87d8b9179ce0984b7b3e9d62a07e6..6cf53a84407053d30947d08fa5de2fd2b37a7644 100644 (file)
@@ -141,6 +141,24 @@ namespace types
 
 }
 
+namespace TrilinosWrapper
+{
+  namespace types
+  {
+#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
+    /**
+     * Declare type of integer used in the Epetra package of Trilinos.
+     */
+    typedef int int_type;
+#else
+    /**
+     * Declare type of integer used in the Epetra package of Trilinos.
+     */
+    typedef long long int_type;
+#endif
+  }
+}
+
 
 // this part of the namespace numbers got moved to the bottom types.h file,
 // because otherwise we get a circular inclusion of config.h, types.h, and
@@ -178,10 +196,12 @@ namespace numbers
    * an invalid array
    * index, an invalid
    * array size, and the
-   * like.
+   * like. Invalid_size_type
+   * is equivalent to
+   * invalid_dof_index.
    */
-  static const std::size_t
-  invalid_size_type = static_cast<std::size_t> (-1);
+  const types::global_dof_index
+  invalid_size_type = static_cast<types::global_dof_index> (-1);
 
   /**
                            * An invalid value for indices of degrees
index 84660978676b30200db96bc1ecc10c2859550fc2..b675d0e70d1287a16f7faec4f7237070a4d7ebcf 100644 (file)
@@ -79,7 +79,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
 
   /**
index ec3e580039418ce9b5e87a67ff1f01ea057a79ed..bb2567c2ea0850ff3d9218da84ca54624e5da86f 100644 (file)
@@ -53,7 +53,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Default
@@ -75,14 +75,14 @@ public:
    * Specialized constructor for a
    * structure with blocks of equal size.
    */
-  explicit BlockIndices(const size_type n_blocks, const size_type block_size = 0);
+  explicit BlockIndices(const unsigned int n_blocks, const size_type block_size = 0);
 
   /**
    * Reinitialize the number of
    * blocks and assign each block
    * the same number of elements.
    */
-  void reinit (const size_type n_blocks,
+  void reinit (const unsigned int n_blocks,
                const size_type n_elements_per_block);
 
   /**
@@ -111,7 +111,7 @@ public:
   /**
    * Number of blocks in index field.
    */
-  size_type size () const;
+  unsigned int size () const;
 
   /**
    * Return the total number of
@@ -120,12 +120,12 @@ public:
    * of the vector space of the
    * block vector.
    */
-  size_type total_size () const;
+  std::size_t total_size () const;
 
   /**
    * The size of the @p ith block.
    */
-  size_type block_size (const size_type i) const;
+  std::size_t block_size (const size_type i) const;
 
   //@}
 
@@ -152,14 +152,14 @@ public:
    * the block, the second the
    * index within it.
    */
-  std::pair<size_type,size_type>
+  std::pair<unsigned int,size_type>
   global_to_local (const size_type i) const;
 
   /**
    * Return the global index of
    * @p index in block @p block.
    */
-  size_type local_to_global (const size_type block,
+  size_type local_to_global (const unsigned int block,
                              const size_type index) const;
 
   /**
@@ -203,7 +203,7 @@ private:
    * we cache this value for faster
    * access.
    */
-  size_type n_blocks;
+  unsigned int n_blocks;
 
   /**
    * Global starting index of each
@@ -333,7 +333,7 @@ const bool IsBlockMatrix<MatrixType>::value;
 
 inline
 void
-BlockIndices::reinit (const size_type nb,
+BlockIndices::reinit (const unsigned int nb,
                       const size_type block_size)
 {
   n_blocks = nb;
@@ -370,7 +370,7 @@ BlockIndices::BlockIndices ()
 
 inline
 BlockIndices::BlockIndices (
-  const size_type n_blocks,
+  const unsigned int n_blocks,
   const size_type block_size)
   :
   n_blocks(n_blocks),
@@ -403,7 +403,7 @@ BlockIndices::push_back(const size_type sz)
 
 
 inline
-std::pair<std::size_t,std::size_t>
+std::pair<unsigned int,BlockIndices::size_type>
 BlockIndices::global_to_local (const size_type i) const
 {
   Assert (i<total_size(), ExcIndexRange(i, 0, total_size()));
@@ -418,8 +418,8 @@ BlockIndices::global_to_local (const size_type i) const
 
 
 inline
-std::size_t
-BlockIndices::local_to_global (const size_type block,
+BlockIndices::size_type
+BlockIndices::local_to_global (const unsigned int block,
                                const size_type index) const
 {
   Assert (block < n_blocks, ExcIndexRange(block, 0, n_blocks));
@@ -431,7 +431,7 @@ BlockIndices::local_to_global (const size_type block,
 
 
 inline
-std::size_t
+unsigned int
 BlockIndices::size () const
 {
   return n_blocks;
@@ -460,7 +460,7 @@ BlockIndices::block_size (const size_type block) const
 
 
 inline
-std::size_t
+BlockIndices::size_type
 BlockIndices::block_start (const size_type block) const
 {
   Assert (block < n_blocks, ExcIndexRange(block, 0, n_blocks));
index ef083063539705b71f22cb16f3aa9c899b2ddc89..bd67329c0adb54c24b001df29867e0ec39184b83 100644 (file)
@@ -51,7 +51,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /// The container for each index set
   typedef std::vector<size_type> block_container;
@@ -341,7 +341,7 @@ BlockList::add(
 
   for (size_type i=0; i<indices.size(); ++i)
     {
-      const types_global_dof_indices k = indices[i];
+      const size_type k = indices[i];
       if (k==numbers::invalid_size_type)
         continue;
       if (selected[i] && std::find(index_sets[block].begin(), index_sets[block].end(), k-offset)
@@ -607,7 +607,7 @@ BlockList::initialize_vertex_patches_mg(
 
 
 inline
-size_type 
+BlockList::size_type 
 BlockList::size() const
 {
   return index_sets.size();
@@ -615,7 +615,7 @@ BlockList::size() const
 
 
 inline
-size_type 
+BlockList::size_type 
 BlockList::block_size(size_type block) const
 {
   return index_sets[block].size();
@@ -641,8 +641,8 @@ BlockList::end(size_type block) const
 
 
 inline
-size_type 
-BlockList::local_index(size_type block, size_type int index) const
+BlockList::size_type 
+BlockList::local_index(size_type block, size_type index) const
 {
   AssertIndexRange(block, index_sets.size());
   const block_container &b = index_sets[block];
index 103398e303519212290378cd372f73a952a2bae5..74aa21c467e07c2c5e6d6cb0f1feaf0ab034229e 100644 (file)
@@ -126,7 +126,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Default constructor creating a
@@ -476,6 +476,11 @@ class BlockTrianglePrecondition
   : private BlockMatrixArray<number>
 {
 public:
+  /**
+   * Declare type for container size.
+   */
+  typedef types::global_dof_index size_type;
+
   /**
    * Default constructor creating a
    * useless object. initialize()
index c8e7073d71e880593fd8bde07177df0e60475bb8..689129dc2d02d2b4688f86d23bd92d65d0d3330f 100644 (file)
@@ -53,6 +53,11 @@ namespace BlockMatrixIterators
   class AccessorBase
   {
   public:
+    /**
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
+
     /**
      * Typedef the value type of the
      * matrix we point into.
@@ -120,6 +125,11 @@ namespace BlockMatrixIterators
     public AccessorBase<BlockMatrix>
   {
   public:
+    /**
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
+
     /**
      * Type of the matrix used in
      * this accessor.
@@ -212,7 +222,12 @@ namespace BlockMatrixIterators
   {
   public:
     /**
-     * Thype of the matrix used in
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
+
+    /**
+     * Type of the matrix used in
      * this accessor.
      */
     typedef const BlockMatrix MatrixType;
@@ -376,7 +391,7 @@ public:
   typedef const value_type       *const_pointer;
   typedef value_type             &reference;
   typedef const value_type       &const_reference;
-  typedef std::size_t             size_type;
+  typedef types::global_dof_index size_type;
 
   typedef
   MatrixIterator<BlockMatrixIterators::Accessor<BlockMatrixBase, false> >
@@ -1274,7 +1289,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type 
+  typename AccessorBase<BlockMatrix>::size_type
   AccessorBase<BlockMatrix>::block_row() const
   {
     Assert (row_block != numbers::invalid_size_type,
@@ -1286,7 +1301,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type 
+  typename AccessorBase<BlockMatrix>::size_type
   AccessorBase<BlockMatrix>::block_column() const
   {
     Assert (col_block != numbers::invalid_size_type,
@@ -1374,7 +1389,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type
+  typename Accessor<BlockMatrix, true>::size_type
   Accessor<BlockMatrix, true>::row() const
   {
     Assert (this->row_block != numbers::invalid_size_type,
@@ -1387,7 +1402,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type
+  typename Accessor<BlockMatrix, true>::size_type
   Accessor<BlockMatrix, true>::column() const
   {
     Assert (this->col_block != numbers::invalid_size_type,
@@ -1558,7 +1573,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type
+  typename Accessor<BlockMatrix, false>::size_type
   Accessor<BlockMatrix, false>::row() const
   {
     Assert (this->row_block != numbers::invalid_size_type,
@@ -1571,7 +1586,7 @@ namespace BlockMatrixIterators
 
   template <class BlockMatrix>
   inline
-  size_type
+  typename Accessor<BlockMatrix, false>::size_type
   Accessor<BlockMatrix, false>::column() const
   {
     Assert (this->col_block != numbers::invalid_size_type,
@@ -1602,7 +1617,7 @@ namespace BlockMatrixIterators
   void
   Accessor<BlockMatrix, false>::set_value (typename Accessor<BlockMatrix, false>::value_type newval) const
   {
-    Assert (this->row_block != numbers::invalid_size_type
+    Assert (this->row_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
     Assert (this->col_block != numbers::invalid_size_type,
             ExcIteratorPastEnd());
@@ -1806,7 +1821,7 @@ BlockMatrixBase<MatrixType>::block (const size_type row,
 
 template <class MatrixType>
 inline
-size_type
+typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::m () const
 {
   return row_block_indices.total_size();
@@ -1816,7 +1831,7 @@ BlockMatrixBase<MatrixType>::m () const
 
 template <class MatrixType>
 inline
-size_type
+typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::n () const
 {
   return column_block_indices.total_size();
@@ -1826,7 +1841,7 @@ BlockMatrixBase<MatrixType>::n () const
 
 template <class MatrixType>
 inline
-size_type 
+typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::n_block_cols () const
 {
   return column_block_indices.size();
@@ -1836,7 +1851,7 @@ BlockMatrixBase<MatrixType>::n_block_cols () const
 
 template <class MatrixType>
 inline
-size_type 
+typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::n_block_rows () const
 {
   return row_block_indices.size();
index cd6c55c94f0fd48468199d7346c9f413cedf0219..2dafec46ee703adf3d9a964c32c48cd15d7be020 100644 (file)
@@ -45,11 +45,6 @@ template <typename number>
 class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
 {
 public:
-  /**
-   * Declare type for container size.
-   */
-  typedef std::size_t size_type;
-
   /**
    * Typedef the base class for simpler
    * access to its own typedefs.
index 215f259e9a0e4241752c26b14511a8fb001651bf..3e603402c2b916391be4aa82fa7a1f29b8d05e47 100644 (file)
@@ -127,7 +127,7 @@ BlockSparseMatrix<number>::empty () const
 
 
 template <typename number>
-size_type 
+typename BlockSparseMatrix<number>::size_type
 BlockSparseMatrix<number>::get_row_length (const size_type row) const
 {
   return sparsity_pattern->row_length(row);
@@ -136,7 +136,7 @@ BlockSparseMatrix<number>::get_row_length (const size_type row) const
 
 
 template <typename number>
-size_type 
+typename BlockSparseMatrix<number>::size_type
 BlockSparseMatrix<number>::n_nonzero_elements () const
 {
   return sparsity_pattern->n_nonzero_elements ();
@@ -145,7 +145,7 @@ BlockSparseMatrix<number>::n_nonzero_elements () const
 
 
 template <typename number>
-size_type 
+typename BlockSparseMatrix<number>::size_type
 BlockSparseMatrix<number>::n_actually_nonzero_elements (const double threshold) const
 {
   size_type count = 0;
index 45448976c831621f5dd34244998352d80c49ddbf..70d48988199cc43a5a7b6bea9c1f583c7e4ee196 100644 (file)
@@ -50,7 +50,7 @@ public:
   /**
    * Declare type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Default constructor. The
@@ -333,7 +333,7 @@ private:
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::n_block_rows () const
 {
   return row_indices.size();
@@ -343,7 +343,7 @@ BlockSparseMatrixEZ<Number>::n_block_rows () const
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::n_rows () const
 {
   return row_indices.total_size();
@@ -353,7 +353,7 @@ BlockSparseMatrixEZ<Number>::n_rows () const
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::n_block_cols () const
 {
   return column_indices.size();
@@ -363,7 +363,7 @@ BlockSparseMatrixEZ<Number>::n_block_cols () const
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::n_cols () const
 {
   return column_indices.total_size();
@@ -401,7 +401,7 @@ BlockSparseMatrixEZ<Number>::block (const size_type row,
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::m () const
 {
   return n_rows();
@@ -411,7 +411,7 @@ BlockSparseMatrixEZ<Number>::m () const
 
 template <typename Number>
 inline
-size_type
+typename BlockSparseMatrixEZ<Number>::size_type
 BlockSparseMatrixEZ<Number>::n () const
 {
   return n_cols();
index 81cfa10a2b78e624bbac0e24ff7d7a37486b18ed..c4ece2ec42a41eb058f5672bc966e8331e881ba9 100644 (file)
@@ -85,7 +85,7 @@ public:
   /**
    * Declare type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Define a value which is used
@@ -1302,7 +1302,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::exists (const size_type i,
 
 template <class SparsityPatternBase>
 inline
-size_type 
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::
 row_length (const size_type row) const
 {
@@ -1321,7 +1321,7 @@ row_length (const size_type row) const
 
 template <class SparsityPatternBase>
 inline
-size_type 
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::n_block_cols () const
 {
   return columns;
@@ -1331,7 +1331,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_block_cols () const
 
 template <class SparsityPatternBase>
 inline
-size_type 
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::n_block_rows () const
 {
   return rows;
@@ -1339,7 +1339,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_block_rows () const
 
 
 inline
-size_type 
+BlockCompressedSimpleSparsityPattern::size_type
 BlockCompressedSimpleSparsityPattern::column_number (const size_type row,
                                                      const size_type index) const
 {
index 6dc910923dbcbd1fcfde30993f5f664da01f3617..d347cf90a7ab4ad9efb18d185d2123315ca67a7c 100644 (file)
@@ -101,7 +101,7 @@ public:
    *  use blocks of different
    *  sizes.
    */
-  explicit BlockVector (const size_type num_blocks = 0,
+  explicit BlockVector (const unsigned int num_blocks = 0,
                         const size_type block_size = 0);
 
   /**
index 608fd7f4ec53f6d22ad1fa492d777913c72fb303..c11397b99688c345125a3f2367d27b6eb99bdb14 100644 (file)
@@ -88,9 +88,9 @@ BlockVector<Number>::BlockVector (const TrilinosWrappers::BlockVector &v)
 
 
 template <typename Number>
-void BlockVector<Number>::reinit (const size_type  n_bl,
-                                  const szie_type  bl_sz,
-                                  const bool       fast)
+void BlockVector<Number>::reinit (const unsigned int n_bl,
+                                  const size_type    bl_sz,
+                                  const bool         fast)
 {
   std::vector<size_type> n(n_bl, bl_sz);
   reinit(n, fast);
index d8545fc9a819e0e613de9c61d7127528a141afda..c1ff69c2e20008ee9bd8be9be79d3e0642905d9a 100644 (file)
@@ -302,7 +302,7 @@ namespace internal
       /**
        * Declare the type for container size.
        */
-      typedef std::size_t size_type;
+      typedef types::global_dof_index size_type;
 
       /**
        * Type of the number this
@@ -739,8 +739,7 @@ public:
   typedef dealii::internal::BlockVectorIterators::Iterator<BlockVectorBase,true>  const_iterator;
   typedef typename BlockType::reference       reference;
   typedef typename BlockType::const_reference const_reference;
-
-  typedef std::size_t                     size_type;
+  typedef types::global_dof_index             size_type;
 
   /**
    * Declare a type that has holds
@@ -836,7 +835,7 @@ public:
    * is the sum of the dimensions of all
    * components.
    */
-  size_type size () const;
+  std::size_t size () const;
 
   /**
    * Return an iterator pointing to
index 44079dbba14af4ba77305bc05b670b8e746d56fe..fd697719025fab1dfb8210bad28dbf7ec29eadbb 100644 (file)
@@ -52,7 +52,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Type of matrix entries. In analogy to
@@ -1230,7 +1230,8 @@ private:
 
 template <typename number>
 inline
-size_type ChunkSparseMatrix<number>::m () const
+typename ChunkSparseMatrix<number>::size_type
+ChunkSparseMatrix<number>::m () const
 {
   Assert (cols != 0, ExcNotInitialized());
   return cols->rows;
@@ -1239,7 +1240,8 @@ size_type ChunkSparseMatrix<number>::m () const
 
 template <typename number>
 inline
-size_type ChunkSparseMatrix<number>::n () const
+typename ChunkSparseMatrix<number>::size_type 
+ChunkSparseMatrix<number>::n () const
 {
   Assert (cols != 0, ExcNotInitialized());
   return cols->cols;
@@ -1249,7 +1251,7 @@ size_type ChunkSparseMatrix<number>::n () const
 
 template <typename number>
 inline
-size_type 
+typename ChunkSparseMatrix<number>::size_type 
 ChunkSparseMatrix<number>::compute_location (const size_type i,
                                              const size_type j) const
 {
index 913610e275e3c5cae4c2ce243a50ffc68ff3a08c..3903dc5639cd92d610f6fdfe8f578f38abfeabbe 100644 (file)
@@ -42,6 +42,11 @@ namespace internal
 // by hand or by using, for example, optimized BLAS versions for them.
   namespace ChunkSparseMatrix
   {
+    /**
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
+
     /**
      * Add the result of multiplying a chunk
      * of size chunk_size times chunk_size by
@@ -363,7 +368,7 @@ ChunkSparseMatrix<number>::empty () const
 
 
 template <typename number>
-size_type 
+typename ChunkSparseMatrix<number>::size_type 
 ChunkSparseMatrix<number>::n_nonzero_elements () const
 {
   Assert (cols != 0, ExcNotInitialized());
@@ -373,7 +378,7 @@ ChunkSparseMatrix<number>::n_nonzero_elements () const
 
 
 template <typename number>
-size_type 
+typename ChunkSparseMatrix<number>::size_type 
 ChunkSparseMatrix<number>::n_actually_nonzero_elements () const
 {
   Assert (cols != 0, ExcNotInitialized());
index f6a2b24e9fb3d37d5a18c95e516bcc17e34a873d..8c6618ba6f3e201dbaee2d436191a36ed8d8b006 100644 (file)
@@ -49,7 +49,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Define a value which is used
@@ -865,7 +865,7 @@ private:
 
 
 inline
-size_type
+ChunkSparsityPattern::size_type
 ChunkSparsityPattern::n_rows () const
 {
   return rows;
@@ -873,7 +873,7 @@ ChunkSparsityPattern::n_rows () const
 
 
 inline
-size_type
+ChunkSparsityPattern::size_type
 ChunkSparsityPattern::n_cols () const
 {
   return cols;
@@ -882,7 +882,7 @@ ChunkSparsityPattern::n_cols () const
 
 
 inline
-size_type 
+ChunkSparsityPattern::size_type
 ChunkSparsityPattern::get_chunk_size () const
 {
   return chunk_size;
index 5ba85606d975106ccb18bb13682f602e8ffef371..4f0379a53b6946d7878cf15c4690882e4a123c6b 100644 (file)
@@ -109,7 +109,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * An iterator that can be used to
@@ -441,7 +441,7 @@ CompressedSetSparsityPattern::Line::add_entries (ForwardIterator begin,
 
 
 inline
-size_type
+CompressedSetSparsityPattern::size_type
 CompressedSetSparsityPattern::n_rows () const
 {
   return rows;
@@ -450,7 +450,7 @@ CompressedSetSparsityPattern::n_rows () const
 
 
 inline
-size_type
+CompressedSetSparsityPattern::size_type
 CompressedSetSparsityPattern::n_cols () const
 {
   return cols;
@@ -487,7 +487,7 @@ CompressedSetSparsityPattern::add_entries (const size_type row,
 
 
 inline
-size_type 
+CompressedSetSparsityPattern::size_type
 CompressedSetSparsityPattern::row_length (const size_type row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
index 9ef3fd35ae6adaaa751bf963939c445cfbc5b9ae..c1f7e642a7a04068f44ca7cfe2c4ae019876b22c 100644 (file)
@@ -90,7 +90,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * An iterator that can be used to
@@ -488,7 +488,7 @@ CompressedSimpleSparsityPattern::Line::add (const size_type j)
 
 
 inline
-std::size_t
+CompressedSimpleSparsityPattern::size_type
 CompressedSimpleSparsityPattern::n_rows () const
 {
   return rows;
@@ -497,7 +497,7 @@ CompressedSimpleSparsityPattern::n_rows () const
 
 
 inline
-std::size_t
+types::global_dof_index
 CompressedSimpleSparsityPattern::n_cols () const
 {
   return cols;
@@ -550,7 +550,7 @@ CompressedSimpleSparsityPattern::Line::Line ()
 
 
 inline
-std::size_t 
+types::global_dof_index
 CompressedSimpleSparsityPattern::row_length (const size_type row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
@@ -565,7 +565,7 @@ CompressedSimpleSparsityPattern::row_length (const size_type row) const
 
 
 inline
-std::size_t 
+types::global_dof_index
 CompressedSimpleSparsityPattern::column_number (const size_type row,
                                                 const size_type index) const
 {
index 2d5328eedbbc2a97cab06260392037d9b2600f40..9ecc0ca4cc31d4842ac3b5df0245b7ab30df2644 100644 (file)
@@ -91,7 +91,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * An iterator that can be used to
@@ -507,7 +507,7 @@ CompressedSparsityPattern::Line::add (const size_type j)
 
 
 inline
-std::size_t
+types::global_dof_index
 CompressedSparsityPattern::n_rows () const
 {
   return rows;
@@ -516,7 +516,7 @@ CompressedSparsityPattern::n_rows () const
 
 
 inline
-std::size_t
+types::global_dof_index
 CompressedSparsityPattern::n_cols () const
 {
   return cols;
@@ -561,7 +561,7 @@ CompressedSparsityPattern::Line::Line ()
 
 
 inline
-std::size_t 
+types::global_dof_index
 CompressedSparsityPattern::row_length (const size_type row) const
 {
   Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
@@ -574,7 +574,7 @@ CompressedSparsityPattern::row_length (const size_type row) const
 
 
 inline
-std::size_t 
+types::global_dof_index
 CompressedSparsityPattern::column_number (const size_type row,
                                           const size_type index) const
 {
index f3bbba92e0d51acaf96963cbf090c6b9628dfcbb..8c261bcc9339b74429351390ce1602a56bd13fc9 100644 (file)
@@ -142,7 +142,7 @@ public:
   /**
    * Declare the type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * An enum that describes what should
@@ -636,7 +636,7 @@ public:
    * consumption (in bytes) of this
    * object.
    */
-  size_type memory_consumption () const;
+  std::size_t memory_consumption () const;
 
   /**
    * @}
@@ -1921,7 +1921,7 @@ ConstraintMatrix::set_inhomogeneity (const size_type line,
 
 
 inline
-std::size_t 
+types::global_dof_index
 ConstraintMatrix::n_constraints () const
 {
   return lines.size();
@@ -1962,7 +1962,7 @@ ConstraintMatrix::is_inhomogeneously_constrained (const size_type index) const
 
 
 inline
-const std::vector<std::pair<std::size_t,double> > *
+const std::vector<std::pair<types::global_dof_index,double> > *
 ConstraintMatrix::get_constraint_entries (const size_type line) const
 {
   // check whether the entry is
@@ -1995,7 +1995,7 @@ ConstraintMatrix::get_inhomogeneity (const size_type line) const
 
 
 
-inline std::size_t 
+inline types::global_dof_index
 ConstraintMatrix::calculate_line_index (const size_type line) const
 {
   //IndexSet is unused (serial case)
index 7dc2082af79eb42096c34477073e96ff12b44216..3aac17b9eb9cf17529a73edda9be403befcb803f 100644 (file)
@@ -730,6 +730,8 @@ namespace internal
   {
     namespace
     {
+      typedef types::global_dof_index size_type;
+
       // TODO: in general we should iterate over the constraints and not over all DoFs
       // for performance reasons
       template<class VEC>
@@ -1007,6 +1009,8 @@ ConstraintMatrix::distribute (VectorType &vec) const
 // local_to_global functions.
 namespace internals
 {
+  typedef types::global_dof_index size_type;
+
   // this struct contains all the information
   // we need to store about each of the
   // global entries (global_row): are they
index 4a1708fa93ed4b4d72b4a6fac55dcd46d3d17d7b..1534bcaa92a74695648586bfc8a6b6ad4eeb2618 100644 (file)
@@ -53,7 +53,7 @@ public:
   /**
    * Declare type of container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Standardized data struct to
index 13d05c53ae28d94cb16107711181fca14ee28cc8..f6d789f1338c6da89d5c0fee40ef9189200664b8 100644 (file)
@@ -209,7 +209,7 @@ public:
   /**
    * Declare the type of container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Accessor class for iterators
@@ -673,7 +673,7 @@ FilteredMatrix<VECTOR>::Accessor::Accessor(
 
 template<class VECTOR>
 inline
-size_type
+types::global_dof_index
 FilteredMatrix<VECTOR>::Accessor::row() const
 {
   return matrix->constraints[index].first;
@@ -683,7 +683,7 @@ FilteredMatrix<VECTOR>::Accessor::row() const
 
 template<class VECTOR>
 inline
-size_type
+types::global_dof_index
 FilteredMatrix<VECTOR>::Accessor::column() const
 {
   return matrix->constraints[index].first;
index 3fcedd85913dea4acf34398294835aae02c51177..e38bb47873928e82c7138cd28542088ebf63d0eb 100644 (file)
@@ -63,7 +63,7 @@ public:
   /**
    * Declare type of container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Type of matrix entries. In analogy to
@@ -1476,7 +1476,7 @@ public:
 
 template <typename number>
 inline
-std::size_t
+types::global_dof_index
 FullMatrix<number>::m() const
 {
   return this->n_rows();
@@ -1486,7 +1486,7 @@ FullMatrix<number>::m() const
 
 template <typename number>
 inline
-std::size_t
+types::global_dof_index
 FullMatrix<number>::n() const
 {
   return this->n_cols();
@@ -1654,7 +1654,7 @@ Accessor (const FullMatrix<number> *matrix,
 
 template <typename number>
 inline
-std::size_t
+types::global_dof_index
 FullMatrix<number>::Accessor::row() const
 {
   return a_row;
@@ -1663,7 +1663,7 @@ FullMatrix<number>::Accessor::row() const
 
 template <typename number>
 inline
-std::size_t
+types::global_dof_index
 FullMatrix<number>::Accessor::column() const
 {
   return a_col;
index 3fe568461942a33d6208771eb6861f219c5b55eb..b64928411405da5e62d2ff7949007fd42169d997 100644 (file)
@@ -97,7 +97,7 @@ namespace parallel
       typedef const value_type                                 *const_iterator;
       typedef value_type                                       &reference;
       typedef const value_type                                 &const_reference;
-      typedef size_t                                            size_type;
+      typedef types::global_dof_index                           size_type;
       typedef typename numbers::NumberTraits<Number>::real_type real_type;
 
       /**
@@ -1373,7 +1373,8 @@ namespace parallel
 
     template <typename Number>
     inline
-    std::size_t Vector<Number>::size () const
+    typename Vector<Number>::size_type
+    Vector<Number>::size () const
     {
       return partitioner->size();
     }
@@ -1382,7 +1383,8 @@ namespace parallel
 
     template <typename Number>
     inline
-    std::size_t Vector<Number>::local_size () const
+    typename Vector<Number>::size_type
+    Vector<Number>::local_size () const
     {
       return partitioner->local_size();
     }
@@ -1391,7 +1393,8 @@ namespace parallel
 
     template <typename Number>
     inline
-    std::pair<std::size_t,std::size_t>
+    std::pair<typename Vector<Number>::size_type,
+      typename Vector<Number>::size_type>
     Vector<Number>::local_range () const
     {
       return partitioner->local_range();
@@ -1412,7 +1415,7 @@ namespace parallel
 
     template <typename Number>
     inline
-    std::size_t 
+    typename Vector<Number>::size_type 
     Vector<Number>::n_ghost_entries () const
     {
       return partitioner->n_ghost_indices();
index 07882b876a42bafbb8e861592f5c6d3e5ec68b9c..fed7aafe65c10a9a68abcff11cc714f06e6849fe 100644 (file)
@@ -252,7 +252,7 @@ namespace PETScWrappers
      */
     typedef PetscScalar               value_type;
     typedef PetscReal                 real_type;
-    typedef std::size_t               size_type;
+    typedef types::global_dof_index   size_type;
     typedef internal::VectorReference reference;
     typedef const internal::VectorReference const_reference;
 
index 738bde20c66e15a7615492f012ba137c2858a56c..0f3d0545880c9b750662bedc061f3ff6977a4ebb 100644 (file)
@@ -48,7 +48,7 @@ public:
   /**
    * Declare type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * @name Constructors and initalization.
@@ -380,7 +380,7 @@ private:
 #ifndef DOXYGEN
 
 template<typename number>
-size_type
+types::global_dof_index
 TridiagonalMatrix<number>::m() const
 {
   return diagonal.size();
@@ -389,7 +389,7 @@ TridiagonalMatrix<number>::m() const
 
 
 template<typename number>
-size_type
+types::global_dof_index
 TridiagonalMatrix<number>::n() const
 {
   return diagonal.size();
index 01b733e0b6985be7e6a5b63ce975a38fdfe58b86..c72568a4152256bb3670206f4b0850a3f405b723 100644 (file)
@@ -73,19 +73,7 @@ namespace TrilinosWrappers
     /**
      * Declare the type for container size.
      */
-    typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-    /**
-     * Declare the type of integer.
-     */
-    typedef int int_type;
-#else
-    /**
-     * Declare the type of integer.
-     */
-    typedef long long int_type;
-#endif
+    typedef types::global_dof_index size_type;
 
     /**
      * Typedef the base class for simpler
index c535f63c5770dba6c3b430925107e8f7682c022d..a707d97f2fb444d25c2906acc1109ed4a352ad5b 100644 (file)
@@ -65,11 +65,6 @@ namespace TrilinosWrappers
   class BlockVector : public BlockVectorBase<Vector>
   {
   public:
-    /**
-     * Declare the type for container size.
-     */
-    typedef std::size_t size_type;
-
     /**
      * Typedef the base class for simpler
      * access to its own typedefs.
index ec8d1bbd868312e709184deb5ff21e1e4ffb8d95..8ad150cebc8817d1645b5f17f0d750cb3b88d75b 100644 (file)
@@ -67,11 +67,6 @@ namespace TrilinosWrappers
     class BlockVector : public BlockVectorBase<Vector>
     {
     public:
-      /**
-       * Declare the type for container size.
-       */
-      typedef std::size_t size_type;
-
       /**
        * Typedef the base class for simpler
        * access to its own typedefs.
index a649ffb011a429ab77ebba09ae22f601a321d3e1..b4683f1ee402dfa58fb4f9d960d1bbab71f324cd 100644 (file)
@@ -75,19 +75,7 @@ namespace TrilinosWrappers
     /**
      * Declare the type for container size.
      */ 
-    typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-    /**
-     * Declare type of integer.
-     */
-    typedef int int_type;
-#else
-    /**
-     * Declare type of integer.
-     */
-    typedef long long int_type;
-#endif
+    typedef types::global_dof_index size_type;
 
     /**
      * Standardized data struct to
@@ -1575,9 +1563,9 @@ namespace TrilinosWrappers
   void PreconditionBase::vmult (dealii::Vector<double>       &dst,
                                 const dealii::Vector<double> &src) const
   {
-    AssertDimension (static_cast<int_type>(dst.size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(dst.size()),
                      preconditioner->OperatorDomainMap().NumMyElements());
-    AssertDimension (static_cast<int_type>(src.size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(src.size()),
                      preconditioner->OperatorRangeMap().NumMyElements());
     Epetra_Vector tril_dst (View, preconditioner->OperatorDomainMap(),
                             dst.begin());
@@ -1593,9 +1581,9 @@ namespace TrilinosWrappers
   void PreconditionBase::Tvmult (dealii::Vector<double>       &dst,
                                  const dealii::Vector<double> &src) const
   {
-    AssertDimension (static_cast<int_type>(dst.size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(dst.size()),
                      preconditioner->OperatorDomainMap().NumMyElements());
-    AssertDimension (static_cast<int_type>(src.size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(src.size()),
                      preconditioner->OperatorRangeMap().NumMyElements());
     Epetra_Vector tril_dst (View, preconditioner->OperatorDomainMap(),
                             dst.begin());
@@ -1615,9 +1603,9 @@ namespace TrilinosWrappers
   PreconditionBase::vmult (parallel::distributed::Vector<double>       &dst,
                            const parallel::distributed::Vector<double> &src) const
   {
-    AssertDimension (static_cast<int_type>(dst.local_size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(dst.local_size()),
                      preconditioner->OperatorDomainMap().NumMyElements());
-    AssertDimension (static_cast<int_type>(src.local_size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(src.local_size()),
                      preconditioner->OperatorRangeMap().NumMyElements());
     Epetra_Vector tril_dst (View, preconditioner->OperatorDomainMap(),
                             dst.begin());
@@ -1633,9 +1621,9 @@ namespace TrilinosWrappers
   PreconditionBase::Tvmult (parallel::distributed::Vector<double>       &dst,
                             const parallel::distributed::Vector<double> &src) const
   {
-    AssertDimension (static_cast<int_type>(dst.local_size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(dst.local_size()),
                      preconditioner->OperatorDomainMap().NumMyElements());
-    AssertDimension (static_cast<int_type>(src.local_size()),
+    AssertDimension (static_cast<TrilinosWrapper::types::int_type>(src.local_size()),
                      preconditioner->OperatorRangeMap().NumMyElements());
     Epetra_Vector tril_dst (View, preconditioner->OperatorDomainMap(),
                             dst.begin());
index 931b4a385f0280b274594e6147e0ca65107baeea..22c7794bc57940e858d9408267579f22dafc5d6b 100644 (file)
@@ -101,19 +101,7 @@ namespace TrilinosWrappers
       /**
        * Declare the type for container size.
        */
-      typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
+      typedef types::global_dof_index size_type;
 
       /**
        * Constructor.
@@ -395,7 +383,7 @@ namespace TrilinosWrappers
       /**
        * Declare type for container size.
        */
-      typedef std::size_t size_type;
+      typedef types::global_dof_index size_type;
 
       /**
        * Typedef for the matrix type
@@ -3029,7 +3017,7 @@ namespace TrilinosWrappers
   bool
   SparseMatrix::in_local_range (const size_type index) const
   {
-    int_type begin, end;
+    TrilinosWrapper::types::int_type begin, end;
     begin = matrix->RowMap().MinMyGID();
     end = matrix->RowMap().MaxMyGID()+1;
 
@@ -3176,15 +3164,15 @@ namespace TrilinosWrappers
 
     last_action = Insert;
 
-    int_type *col_index_ptr;
+    TrilinosWrapper::types::int_type *col_index_ptr;
     TrilinosScalar const *col_value_ptr;
-    int_type n_columns;
+    TrilinosWrapper::types::int_typeint_type n_columns;
 
     // If we don't elide zeros, the pointers
     // are already available...
     if (elide_zero_values == false)
       {
-        col_index_ptr = (int_type *)col_indices;
+        col_index_ptr = (TrilinosWrapper::types::int_type *)col_indices;
         col_value_ptr = values;
         n_columns = n_cols;
       }
@@ -3212,9 +3200,9 @@ namespace TrilinosWrappers
               }
           }
 
-        Assert(n_columns <= (int_type)n_cols, ExcInternalError());
+        Assert(n_columns <= (TrilinosWrapper::types::int_type)n_cols, ExcInternalError());
 
-        col_index_ptr = (int_type *)&column_indices[0];
+        col_index_ptr = (TrilinosWrapper::types::int_type *)&column_indices[0];
         col_value_ptr = &column_values[0];
       }
 
@@ -3233,7 +3221,7 @@ namespace TrilinosWrappers
     // add the possibility to insert new values,
     // and in the second we just replace
     // data.
-    if (row_partitioner().MyGID(static_cast<int_type>(row)) == true)
+    if (row_partitioner().MyGID(static_cast<TrilinosWrapper::types::int_type>(row)) == true)
       {
         if (matrix->Filled() == false)
           {
@@ -3270,7 +3258,8 @@ namespace TrilinosWrappers
 
         if (matrix->Filled() == false)
           {
-            ierr = matrix->InsertGlobalValues (1, (int_type *)&row,
+            ierr = matrix->InsertGlobalValues (1, 
+                                               (TrilinosWrapper::types::int_type *)&row,
                                                n_columns, col_index_ptr,
                                                &col_value_ptr,
                                                Epetra_FECrsMatrix::ROW_MAJOR);
@@ -3278,7 +3267,8 @@ namespace TrilinosWrappers
               ierr = 0;
           }
         else
-          ierr = matrix->ReplaceGlobalValues (1, (int_type *)&row,
+          ierr = matrix->ReplaceGlobalValues (1, 
+                                              (TrilinosWrapper::types::int_type *)&row,
                                               n_columns, col_index_ptr,
                                               &col_value_ptr,
                                               Epetra_FECrsMatrix::ROW_MAJOR);
@@ -3404,15 +3394,15 @@ namespace TrilinosWrappers
 
     last_action = Add;
 
-    int_type *col_index_ptr;
+    TrilinosWrapper::types::int_type *col_index_ptr;
     TrilinosScalar const *col_value_ptr;
-    int_type n_columns;
+    TrilinosWrapper::types::int_type n_columns;
 
     // If we don't elide zeros, the pointers
     // are already available...
     if (elide_zero_values == false)
       {
-        col_index_ptr = (int_type *)col_indices;
+        col_index_ptr = (TrilinosWrapper::types::int_type *)col_indices;
         col_value_ptr = values;
         n_columns = n_cols;
 #ifdef DEBUG
@@ -3443,9 +3433,9 @@ namespace TrilinosWrappers
               }
           }
 
-        Assert(n_columns <= (int_type)n_cols, ExcInternalError());
+        Assert(n_columns <= (TrilinosWrapper::types::int_type)n_cols, ExcInternalError());
 
-        col_index_ptr = (int_type *)&column_indices[0];
+        col_index_ptr = (TrilinosWrapper::types::int_type *)&column_indices[0];
         col_value_ptr = &column_values[0];
       }
 
@@ -3454,7 +3444,7 @@ namespace TrilinosWrappers
     // can directly call the Epetra_CrsMatrix
     // input function, which is much faster
     // than the Epetra_FECrsMatrix function.
-    if (row_partitioner().MyGID(static_cast<int_type>(row)) == true)
+    if (row_partitioner().MyGID(static_cast<TrilinosWrapper::types::int_type>(row)) == true)
       {
         ierr = matrix->Epetra_CrsMatrix::SumIntoGlobalValues(row, n_columns,
                                                              const_cast<double *>(col_value_ptr),
@@ -3474,7 +3464,8 @@ namespace TrilinosWrappers
         // one element at a time).
         compressed = false;
 
-        ierr = matrix->SumIntoGlobalValues (1, (int_type *)&row, n_columns,
+        ierr = matrix->SumIntoGlobalValues (1, 
+                                            (TrilinosWrapper::types::int_type *)&row, n_columns,
                                             col_index_ptr,
                                             &col_value_ptr,
                                             Epetra_FECrsMatrix::ROW_MAJOR);
@@ -3488,15 +3479,15 @@ namespace TrilinosWrappers
         std::cout << "Got error " << ierr << " in row " << row
                   << " of proc " << row_partitioner().Comm().MyPID()
                   << " when trying to add the columns:" << std::endl;
-        for (int_type i=0; i<n_columns; ++i)
+        for (TrilinosWrapper::types::int_type i=0; i<n_columns; ++i)
           std::cout << col_index_ptr[i] << " ";
         std::cout << std::endl << std::endl;
         std::cout << "Matrix row has the following indices:" << std::endl;
-        int_type n_indices, *indices;
-        trilinos_sparsity_pattern().ExtractMyRowView(row_partitioner().LID(static_cast<int_type>(row)),
+        TrilinosWrapper::types::int_type n_indices, *indices;
+        trilinos_sparsity_pattern().ExtractMyRowView(row_partitioner().LID(static_cast<TrilinosWrapper::types::int_type>(row)),
                                                      n_indices,
                                                      indices);
-        for (int_type i=0; i<n_indices; ++i)
+        for (TrilinosWrapper::types::int_type i=0; i<n_indices; ++i)
           std::cout << indices[i] << " ";
         std::cout << endl << std::endl;
         Assert (ierr <= 0,
index b1ec5e4c72e118ef4a8cb779c198a6831f87bd3a..c25da1d75f7c6188bbfe3371977665ca86b53695 100644 (file)
@@ -73,20 +73,7 @@ namespace TrilinosWrappers
       /**
        * Declare type for container size.
        */
-      typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
-
+      typedef types::global_dof_index size_type;
 
       /**
        * Constructor.
@@ -1597,7 +1584,7 @@ namespace TrilinosWrappers
   bool
   SparsityPattern::in_local_range (const size_type index) const
   {
-    int_type begin, end;
+    TrilinosWrapper::types::int_type begin, end;
     begin = graph->RowMap().MinMyGID();
     end = graph->RowMap().MaxMyGID()+1;
 
@@ -1646,11 +1633,14 @@ namespace TrilinosWrappers
     if (begin == end)
       return;
 
-    int_type *col_index_ptr = (int_type *)(&*begin);
-    const int_type n_cols = static_cast<int_type>(end - begin);
+    TrilinosWrapper::types::int_type *col_index_ptr = 
+      (TrilinosWrapper::types::int_type *)(&*begin);
+    const TrilinosWrapper::types::int_type n_cols = 
+      static_cast<TrilinosWrapper::types::int_type>(end - begin);
     compressed = false;
 
-    const int ierr = graph->InsertGlobalIndices (1, (int_type *)&row,
+    const int ierr = graph->InsertGlobalIndices (1, 
+                                                 (TrilinosWrapper::types::int_type *)&row,
                                                  n_cols, col_index_ptr);
 
     AssertThrow (ierr >= 0, ExcTrilinosError(ierr));
@@ -1819,7 +1809,7 @@ namespace TrilinosWrappers
   SparsityPattern::reinit (const IndexSet     &row_parallel_partitioning,
                            const IndexSet     &col_parallel_partitioning,
                            const MPI_Comm     &communicator,
-                           const std::vector<int_type> &n_entries_per_row)
+                           const std::vector<TrilinosWrapper::types::int_type> &n_entries_per_row)
   {
     Epetra_Map row_map =
       row_parallel_partitioning.make_trilinos_map (communicator, false);
index 6baf82634fb66885f6d468fed8782b2953da5229..285fad64fcacebe9aaede2b876c42ccaf6acddbd 100644 (file)
@@ -169,20 +169,7 @@ namespace TrilinosWrappers
       /**
        * Declare type for container size.
        */
-      typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
-
+      typedef types::global_dof_index size_type;
 
       /**
        * @name Basic constructors and initalization.
@@ -528,12 +515,12 @@ namespace TrilinosWrappers
 
       has_ghosts = vector->Map().UniqueGIDs()==false;
 
-      const int_type size = parallel_partitioner.NumMyElements();
+      const TrilinosWrapper::types::int_type size = parallel_partitioner.NumMyElements();
 
       // Need to copy out values, since the
       // deal.II might not use doubles, so
       // that a direct access is not possible.
-      for (int_type i=0; i<size; ++i)
+      for (Trilinos::Wrapper::Types::int_type i=0; i<size; ++i)
         (*vector)[0][i] = v(parallel_partitioner.GID(i));
     }
 
@@ -589,27 +576,10 @@ namespace TrilinosWrappers
   class Vector : public VectorBase
   {
   public:
-#ifdef EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type for container size.
-       */
-      typedef unsigned int size_type;
-
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type for container size.
-       */
-      typedef uint64_t size_type;
-
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
+    /**
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
 
     /**
      * Default constructor that
@@ -811,7 +781,7 @@ namespace TrilinosWrappers
   template <typename number>
   Vector::Vector (const dealii::Vector<number> &v)
   {
-    Epetra_LocalMap map ((int_type)v.size(), 0, Utilities::Trilinos::comm_self());
+    Epetra_LocalMap map ((TrilinosWrapper::types::int_type)v.size(), 0, Utilities::Trilinos::comm_self());
     vector.reset (new Epetra_FEVector(map));
     *this = v;
   }
@@ -837,13 +807,13 @@ namespace TrilinosWrappers
       {
         vector.reset();
 
-        Epetra_LocalMap map ((int_type)v.size(), 0,
+        Epetra_LocalMap map ((TrilinosWrapper::types::int_type)v.size(), 0,
                              Utilities::Trilinos::comm_self());
         vector.reset (new Epetra_FEVector(map));
       }
 
     const Epetra_Map &map = vector_partitioner();
-    const int_type size = map.NumMyElements();
+    const TrilinosWrapper::types::int_type size = map.NumMyElements();
 
     Assert (map.MaxLID() == size-1,
             ExcDimensionMismatch(map.MaxLID(), size-1));
@@ -851,7 +821,7 @@ namespace TrilinosWrappers
     // Need to copy out values, since the
     // deal.II might not use doubles, so
     // that a direct access is not possible.
-    for (int_type i=0; i<size; ++i)
+    for (TrilinosWrapper::types::int_type i=0; i<size; ++i)
       (*vector)[0][i] = v(i);
 
     return *this;
index 8ac308fbf1862075b354b72dd397c6451d02f680..6a13d093a265f6a3da5906844d3a6043573a18a4 100644 (file)
@@ -97,19 +97,7 @@ namespace TrilinosWrappers
       /**
        * Declare type for container size.
        */
-      typedef std::size_t size_type;
-
-#ifdef DEAL_II_EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
+      typedef types::global_dof_index size_type;
 
       /**
        * This looks like a copy
@@ -282,22 +270,10 @@ namespace TrilinosWrappers
      */
     typedef TrilinosScalar            value_type;
     typedef TrilinosScalar            real_type;
-    typedef std::size_t               size_type;
+    typedef types::global_dof_index   size_type;
     typedef internal::VectorReference reference;
     typedef const internal::VectorReference const_reference;
 
-#ifdef EPETRA_NO_64BIT_GLOBAL_INDICES
-      /**
-       * Declare type of integer.
-       */
-      typedef int int_type;
-#else
-      /**
-       * Declare type of integer.
-       */
-      typedef long long int_type;
-#endif
-
     /**
      * @name 1: Basic Object-handling
      */
@@ -1405,11 +1381,11 @@ namespace TrilinosWrappers
     for (size_type i=0; i<n_elements; ++i)
       {
         const size_type row = indices[i];
-        const int_type local_row = vector->Map().LID(static_cast<int_type>(row));
+        const TrilinosWrapper::types::int_type local_row = vector->Map().LID(static_cast<TrilinosWrapper::Types::int_type>(row));
         if (local_row == -1)
           {
             const int ierr = vector->ReplaceGlobalValues (1,
-                                                          (const int_type *)(&row),
+                                                          (const TrilinosWrapper::types::int_type *)(&row),
                                                           &values[i]);
             AssertThrow (ierr == 0, ExcTrilinosError(ierr));
             compressed = false;
@@ -1473,11 +1449,11 @@ namespace TrilinosWrappers
     for (size_type i=0; i<n_elements; ++i)
       {
         const size_type row = indices[i];
-        const int_type local_row = vector->Map().LID(static_cast<int_type>(row));
+        const TrilinosWrapper::types::int_type local_row = vector->Map().LID(static_cast<TrilinosWrapper::Types::int_type>(row));
         if (local_row == -1)
           {
             const int ierr = vector->SumIntoGlobalValues (1,
-                                                          (const int_type *)(&row),
+                                                          (const TrilinosWrapper::types::int_type *)(&row),
                                                           &values[i]);
             AssertThrow (ierr == 0, ExcTrilinosError(ierr));
             compressed = false;
@@ -1512,7 +1488,7 @@ namespace TrilinosWrappers
   std::pair<size_type, size_type>
   VectorBase::local_range () const
   {
-    int_type begin, end;
+    TrilinosWrapper::types::int_type begin, end;
     begin = vector->Map().MinMyGID();
     end = vector->Map().MaxMyGID()+1;
     return std::make_pair (begin, end);
index ce51bf021bf129ed938fc6af69bde3e655688895..925915cf7b9cff33a29b2338bacd96e50c925bb6 100644 (file)
@@ -117,7 +117,7 @@ public:
   typedef const value_type                                 *const_iterator;
   typedef value_type                                       &reference;
   typedef const value_type                                 &const_reference;
-  typedef std::size_t                                       size_type;
+  typedef types::global_dof_index                           size_type;
 
   /**
    * Declare a type that has holds
@@ -590,7 +590,7 @@ public:
   /**
    * Return dimension of the vector.
    */
-  size_type size () const;
+  std::size_t size () const;
 
   /**
    * Return whether the vector contains only
@@ -998,7 +998,7 @@ public:
    * memory consumption (in bytes)
    * of this object.
    */
-  size_type memory_consumption () const;
+  std::size_t memory_consumption () const;
   //@}
 
   /**
index 816fe8116e22fa186bd5c5ced0ea7ab67a510ae7..03234afcc0175f1731c2a58f62e6e690fd19c31c 100644 (file)
@@ -322,6 +322,8 @@ namespace internal
 {
   namespace Vector
   {
+    typedef types::global_dof_index size_type;
+
     template<typename T>
     void set_subrange (const T            s,
                        const size_type begin,
@@ -1432,7 +1434,7 @@ void Vector<Number>::block_read (std::istream &in)
 
 
 template <typename Number>
-size_type
+std::size_t
 Vector<Number>::memory_consumption () const
 {
   return sizeof(*this) + (max_vec_size * sizeof(Number));
index c61e34c3aaa572b67b0dfa42ef30defee5e9dd5e..aadd6eaa594b7cc09fd572a1b7378c56a7c1265b 100644 (file)
@@ -256,7 +256,7 @@ public:
   /**
    * Declare type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Constructor.  The argument
index b2dd304a9d29805d492b178cf757913aae123ce5..72fae49f8e5733987ed00d25473dced3279188b1 100644 (file)
@@ -136,7 +136,7 @@ public:
   /**
    * Declare type for container size.
    */
-  typedef std::size_t size_type;
+  typedef types::global_dof_index size_type;
 
   /**
    * Read write constructor. Takes the size
index 06d4885148adb520ba71e78920405db9a82796b2..9a28ef5686d99dbcd93049f5af81e1b297a21abf 100644 (file)
@@ -41,16 +41,6 @@ namespace internal
     template <typename Number>
     struct ConstraintValues
     {
-      /**
-       * In the definition of next_constraint and constraints below,
-       * there is an argument that is in fact the size of constraints.
-       * To be clarified, we explicitly use the size_type of the 
-       * std::map container as the type. We define the size_type for 
-       * a container that contains <int, int> rather than the real
-       * types in the `constraints' object to avoid self-recursiveness.
-       */
-      typedef std::map<int, int>::size_type size_type;
-      
       ConstraintValues();
 
       /**
@@ -66,8 +56,8 @@ namespace internal
       std::vector<std::pair<types::global_dof_index, double> > constraint_entries;
       std::vector<types::global_dof_index> constraint_indices;
 
-      std::pair<std::vector<Number>, size_type> next_constraint;
-      std::map<std::vector<Number>, size_type, FPArrayComparator<double> > constraints;
+      std::pair<std::vector<Number>, types::global_dof_index> next_constraint;
+      std::map<std::vector<Number>, types::global_dof_index, FPArrayComparator<double> > constraints;
     };
 
 
@@ -89,7 +79,7 @@ namespace internal
           constraint_entries = entries;
           std::sort(constraint_entries.begin(), constraint_entries.end(),
                     ConstraintComparator());
-          for (size_type j=0; j<constraint_entries.size(); j++)
+          for (types::global_dof_index j=0; j<constraint_entries.size(); j++)
             {
               // copy the indices of the constraint entries after sorting.
               constraint_indices[j] = constraint_entries[j].first;
@@ -107,11 +97,11 @@ namespace internal
       // equal. this was quite lenghty and now we use a std::map with a
       // user-defined comparator to compare floating point arrays to a
       // tolerance 1e-13.
-      std::pair<typename std::map<std::vector<double>, size_type,
+      std::pair<typename std::map<std::vector<double>, types::global_dof_index,
           FPArrayComparator<double> >::iterator,
           bool> it = constraints.insert(next_constraint);
 
-      size_type insert_position = deal_II_numbers::invalid_unsigned_int;
+      types::global_dof_index insert_position = deal_II_numbers::invalid_dof_index;
       if (it.second == false)
         insert_position = it.first->second;
       else
index 3a63bce74f65ee543436ae58a4279390b92527f6..dcb82f4c1479c70e223b41723c9c6c6c9aab8fb4 100644 (file)
@@ -249,7 +249,7 @@ BlockMatrixArray<number>::matrix_norm_square (
 
 
 template <typename number>
-size_type 
+typename BlockMatrixArray<number>::size_type
 BlockMatrixArray<number>::n_block_rows () const
 {
   return block_rows;
@@ -258,7 +258,7 @@ BlockMatrixArray<number>::n_block_rows () const
 
 
 template <typename number>
-size_type 
+typename BlockMatrixArray<number>::size_type
 BlockMatrixArray<number>::n_block_cols () const
 {
   return block_cols;
index 0001be1ec222212f86375061293aafe98af14b4d..68318e34cf82ba3c9c25a93b7ca4be5d525e264e 100644 (file)
@@ -180,7 +180,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::empty () const
 
 
 template <class SparsityPatternBase>
-size_type 
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::max_entries_per_row () const
 {
   size_type max_entries = 0;
@@ -199,7 +199,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::max_entries_per_row () const
 
 
 template <class SparsityPatternBase>
-size_type
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::n_rows () const
 {
   // only count in first column, since
@@ -213,7 +213,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_rows () const
 
 
 template <class SparsityPatternBase>
-size_type
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::n_cols () const
 {
   // only count in first row, since
@@ -227,7 +227,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_cols () const
 
 
 template <class SparsityPatternBase>
-size_type 
+typename BlockSparsityPatternBase<SparsityPatternBase>::size_type
 BlockSparsityPatternBase<SparsityPatternBase>::n_nonzero_elements () const
 {
   size_type count = 0;
index 59f8770389adaa9e1d4b9b532d17b07c2bc353c7..79a3aaabe6c3d9c90cd19edfa703104207b6c7ec 100644 (file)
@@ -103,7 +103,7 @@ ChunkSparsityPattern::ChunkSparsityPattern (const size_type n,
 
 
 ChunkSparsityPattern::ChunkSparsityPattern (
-  const types::global_dof_index m,
+  const size_type m,
   const std::vector<size_type> &row_lengths,
   const size_type chunk_size,
   const bool)
@@ -176,8 +176,8 @@ ChunkSparsityPattern::reinit (const size_type m,
 
 void
 ChunkSparsityPattern::reinit (
-  const types::global_dof_index m,
-  const types::global_dof_index n,
+  const size_type m,
+  const size_type n,
   const VectorSlice<const std::vector<size_type> > &row_lengths,
   const size_type chunk_size,
   const bool)
@@ -256,6 +256,11 @@ namespace internal
 {
   namespace
   {
+    /**
+     * Declare type for container size.
+     */
+    typedef types::global_dof_index size_type;
+
     // distinguish between compressed sparsity types that define row_begin()
     // and SparsityPattern that uses begin() as iterator type
     template <typename Sparsity>
@@ -390,7 +395,7 @@ ChunkSparsityPattern::empty () const
 
 
 
-size_type 
+ChunkSparsityPattern::size_type 
 ChunkSparsityPattern::max_entries_per_row () const
 {
   return sparsity_pattern.max_entries_per_row() * chunk_size;
@@ -422,7 +427,7 @@ ChunkSparsityPattern::exists (const size_type i,
 
 
 
-size_type 
+ChunkSparsityPattern::size_type 
 ChunkSparsityPattern::row_length (const size_type i) const
 {
   Assert (i<rows, ExcIndexRange(i,0,rows));
@@ -447,7 +452,7 @@ ChunkSparsityPattern::symmetrize ()
 
 
 
-size_type 
+ChunkSparsityPattern::size_type 
 ChunkSparsityPattern::n_nonzero_elements () const
 {
   if ((n_rows() % chunk_size == 0)
@@ -590,7 +595,7 @@ ChunkSparsityPattern::print_gnuplot (std::ostream &out) const
 
 
 
-size_type 
+ChunkSparsityPattern::size_type 
 ChunkSparsityPattern::bandwidth () const
 {
   // calculate the bandwidth from that of the
index 47007d37aa29965be500212645dd5721822b8d76..59b83e651e585caec88c51f6a691aea249b16bcd 100644 (file)
@@ -108,7 +108,7 @@ CompressedSetSparsityPattern::empty () const
 
 
 
-size_type 
+CompressedSetSparsityPattern::size_type 
 CompressedSetSparsityPattern::max_entries_per_row () const
 {
   size_type m = 0;
@@ -211,7 +211,7 @@ CompressedSetSparsityPattern::print_gnuplot (std::ostream &out) const
 
 
 
-size_type 
+CompressedSetSparsityPattern::size_type 
 CompressedSetSparsityPattern::bandwidth () const
 {
   size_type b=0;
@@ -229,7 +229,7 @@ CompressedSetSparsityPattern::bandwidth () const
 
 
 
-size_type 
+CompressedSetSparsityPattern::size_type 
 CompressedSetSparsityPattern::n_nonzero_elements () const
 {
   size_type n=0;
index 577e92aece1283cd5e9d31425c64e5d1c79ea2f3..07206370d975910b9edfb17915c3faae196b7f4e 100644 (file)
@@ -206,7 +206,7 @@ CompressedSimpleSparsityPattern::Line::add_entries (ForwardIterator begin,
 }
 
 
-std::size_t
+CompressedSimpleSparsityPattern::size_type
 CompressedSimpleSparsityPattern::Line::memory_consumption () const
 {
   return entries.capacity()*sizeof(size_type)+sizeof(Line);
@@ -306,7 +306,7 @@ CompressedSimpleSparsityPattern::empty () const
 
 
 
-size_type 
+CompressedSimpleSparsityPattern::size_type 
 CompressedSimpleSparsityPattern::max_entries_per_row () const
 {
   size_type m = 0;
@@ -419,7 +419,7 @@ CompressedSimpleSparsityPattern::print_gnuplot (std::ostream &out) const
 
 
 
-size_type 
+CompressedSimpleSparsityPattern::size_type 
 CompressedSimpleSparsityPattern::bandwidth () const
 {
   size_type b=0;
@@ -440,7 +440,7 @@ CompressedSimpleSparsityPattern::bandwidth () const
 
 
 
-size_type 
+CompressedSimpleSparsityPattern::size_type 
 CompressedSimpleSparsityPattern::n_nonzero_elements () const
 {
   size_type n=0;
@@ -453,7 +453,7 @@ CompressedSimpleSparsityPattern::n_nonzero_elements () const
 }
 
 
-size_type
+CompressedSimpleSparsityPattern::size_type
 CompressedSimpleSparsityPattern::memory_consumption () const
 {
   //TODO: IndexSet...
index 740c529b1842802b8f40e439409fdee3871dfa41..273f3bf726901d1985c26b780e8ee718e9dd6ad0 100644 (file)
@@ -400,7 +400,7 @@ CompressedSparsityPattern::empty () const
 
 
 
-size_type 
+CompressedSparsityPattern::size_type 
 CompressedSparsityPattern::max_entries_per_row () const
 {
   size_type m = 0;
@@ -511,7 +511,7 @@ CompressedSparsityPattern::print_gnuplot (std::ostream &out) const
 
 
 
-size_type 
+CompressedSparsityPattern::size_type 
 CompressedSparsityPattern::bandwidth () const
 {
   size_type b=0;
@@ -532,7 +532,7 @@ CompressedSparsityPattern::bandwidth () const
 
 
 
-size_type 
+CompressedSparsityPattern::size_type 
 CompressedSparsityPattern::n_nonzero_elements () const
 {
   size_type n=0;
index e0929273e27f5091cfa83f91d2c05c7058333daf..e4c69da6fbddb5883c0dc7dc8f39e929a45cdb9a 100644 (file)
@@ -77,7 +77,7 @@ ConstraintMatrix::ConstraintLine::operator == (const ConstraintLine &a) const
 
 
 
-size_type
+std::size_t
 ConstraintMatrix::ConstraintLine::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (line) +
@@ -212,7 +212,7 @@ void ConstraintMatrix::close ()
   // in debug mode: check whether we really
   // set the pointers correctly.
   for (size_type i=0; i<lines_cache.size(); ++i)
-    if (lines_cache[i] != numbers::invalid_size_int)
+    if (lines_cache[i] != numbers::invalid_size_type)
       Assert (i == calculate_line_index(lines[lines_cache[i]].line),
               ExcInternalError());
 
@@ -2139,7 +2139,8 @@ bool ConstraintMatrix::is_identity_constrained (const size_type index) const
 
 
 
-size_type ConstraintMatrix::max_constraint_indirections () const
+ConstraintMatrix::size_type 
+ConstraintMatrix::max_constraint_indirections () const
 {
   size_type return_value = 0;
   for (std::vector<ConstraintLine>::const_iterator i=lines.begin();
@@ -2230,7 +2231,7 @@ ConstraintMatrix::write_dot (std::ostream &out) const
 
 
 
-size_type
+std::size_t
 ConstraintMatrix::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (lines) +
@@ -2277,7 +2278,7 @@ ConstraintMatrix::memory_consumption () const
 #define PARALLEL_VECTOR_FUNCTIONS(VectorType) \
   template void ConstraintMatrix:: \
   distribute_local_to_global<VectorType > (const Vector<double>            &, \
-                                           const std::vector<std::size_t>  &, \
+                                           const std::vector<ConstraintMatrix::size_type>  &, \
                                            VectorType                      &, \
                                            const FullMatrix<double>        &) const
 
@@ -2301,7 +2302,7 @@ PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::BlockVector);
   template void ConstraintMatrix:: \
   distribute_local_to_global<MatrixType,VectorType > (const FullMatrix<double>        &, \
                                                       const Vector<double>            &, \
-                                                      const std::vector<std::size_t> &, \
+                                                      const std::vector<ConstraintMatrix::size_type> &, \
                                                       MatrixType                      &, \
                                                       VectorType                      &, \
                                                       bool                             , \
@@ -2310,7 +2311,7 @@ PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::BlockVector);
   template void ConstraintMatrix:: \
   distribute_local_to_global<MatrixType,Vector<double> > (const FullMatrix<double>        &, \
                                                           const Vector<double>            &, \
-                                                          const std::vector<std::size_t> &, \
+                                                          const std::vector<ConstraintMatrix::size_type> &, \
                                                           MatrixType                      &, \
                                                           Vector<double>                  &, \
                                                           bool                             , \
@@ -2319,7 +2320,7 @@ PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::BlockVector);
   template void ConstraintMatrix:: \
   distribute_local_to_global<MatrixType,VectorType > (const FullMatrix<double>        &, \
                                                       const Vector<double>            &, \
-                                                      const std::vector<std::size_t> &, \
+                                                      const std::vector<ConstraintMatrix::size_type> &, \
                                                       MatrixType                      &, \
                                                       VectorType                      &, \
                                                       bool                             , \
@@ -2328,7 +2329,7 @@ PARALLEL_VECTOR_FUNCTIONS(TrilinosWrappers::MPI::BlockVector);
   template void ConstraintMatrix:: \
   distribute_local_to_global<MatrixType,Vector<double> > (const FullMatrix<double>        &, \
                                                           const Vector<double>            &, \
-                                                          const std::vector<std::size_t> &, \
+                                                          const std::vector<ConstraintMatrix::size_type> &, \
                                                           MatrixType                      &, \
                                                           Vector<double>                  &, \
                                                           bool                             , \
@@ -2379,27 +2380,27 @@ BLOCK_MATRIX_VECTOR_FUNCTIONS(TrilinosWrappers::BlockSparseMatrix, TrilinosWrapp
 
 #define SPARSITY_FUNCTIONS(SparsityType) \
   template void ConstraintMatrix::add_entries_local_to_global<SparsityType> (\
-      const std::vector<std::size_t> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
       SparsityType &,                    \
       const bool,                        \
       const Table<2,bool> &, \
       internal::bool2type<false>) const; \
   template void ConstraintMatrix::add_entries_local_to_global<SparsityType> (\
-      const std::vector<std::size_t> &, \
-      const std::vector<std::size_t> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
       SparsityType &,                    \
       const bool,                        \
       const Table<2,bool> &) const
 #define BLOCK_SPARSITY_FUNCTIONS(SparsityType) \
   template void ConstraintMatrix::add_entries_local_to_global<SparsityType> (\
-      const std::vector<std::size_t> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
       SparsityType &,                    \
       const bool,                        \
       const Table<2,bool> &, \
       internal::bool2type<true>) const; \
   template void ConstraintMatrix::add_entries_local_to_global<SparsityType> (\
-      const std::vector<std::size_t> &, \
-      const std::vector<std::size_t> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
       SparsityType &,                    \
       const bool,                        \
       const Table<2,bool> &) const
@@ -2422,8 +2423,8 @@ BLOCK_SPARSITY_FUNCTIONS(TrilinosWrappers::BlockSparsityPattern);
 #define ONLY_MATRIX_FUNCTIONS(MatrixType) \
   template void ConstraintMatrix::distribute_local_to_global<MatrixType > (\
       const FullMatrix<double>        &, \
-      const std::vector<std::size_t> &, \
-      const std::vector<std::size_t> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
+      const std::vector<ConstraintMatrix::size_type> &, \
       MatrixType                      &) const
 
 ONLY_MATRIX_FUNCTIONS(SparseMatrix<float>);
index a3cee9ef7f91c5cc561ab0c6f31627334315f7e9..4ea65083a47615724cf322e99d3cf17445e321f3 100644 (file)
@@ -148,7 +148,7 @@ namespace TrilinosWrappers
     std::vector<Epetra_Map> parallel_partitioning;
     for (size_type i=0; i<block_sparsity_pattern.n_block_rows(); ++i)
       parallel_partitioning.push_back
-      (Epetra_Map(static_cast<int_type>(block_sparsity_pattern.block(i,0).n_rows()),
+      (Epetra_Map(static_cast<TrilinosWrapper::types::int_type>(block_sparsity_pattern.block(i,0).n_rows()),
                   0,
                   Utilities::Trilinos::comm_self()));
 
@@ -240,7 +240,7 @@ namespace TrilinosWrappers
 
     std::vector<Epetra_Map> parallel_partitioning;
     for (size_type i=0; i<dealii_block_sparse_matrix.n_block_rows(); ++i)
-      parallel_partitioning.push_back (Epetra_Map(static_cast<int_type>(dealii_block_sparse_matrix.block(i,0).m()),
+      parallel_partitioning.push_back (Epetra_Map(static_cast<TrilinosWrapper::types::int_type>(dealii_block_sparse_matrix.block(i,0).m()),
                                                   0,
                                                   trilinos_communicator));
 
index 8f5afe056b6332b8d0bc90a3ca6d1eaaca547a2c..3a1d36fab78093a1bb891804d87ff0b8a40931b2 100644 (file)
@@ -602,7 +602,8 @@ namespace TrilinosWrappers
         for (size_type d=0; d<constant_modes_dimension; ++d)
           for (size_type row=0; row<my_size; ++row)
             {
-              int_type global_row_id = constant_modes_are_global ? domain_map.GID(row) : row;
+              TrilinosWrapper::types::int_type global_row_id = 
+                constant_modes_are_global ? domain_map.GID(row) : row;
               distributed_constant_modes[d][row] =
                 additional_data.constant_modes[d][global_row_id];
             }
@@ -662,7 +663,8 @@ namespace TrilinosWrappers
     // equidistributed map; avoid
     // storing the nonzero
     // elements.
-    vector_distributor.reset (new Epetra_Map(static_cast<int_type>(n_rows), 0, communicator));
+    vector_distributor.reset (new Epetra_Map(static_cast<TrilinosWrapper::types::int_type>(n_rows), 
+          0, communicator));
 
     if (trilinos_matrix.get() == 0)
       trilinos_matrix.reset (new SparseMatrix());
index 352726816317bd7670e6bbd16eb61b1702a8949e..41631c5486e63602af6c15f202d9e577f87dbb1d 100644 (file)
@@ -54,8 +54,8 @@ namespace TrilinosWrappers
 
       // get a representation of the present
       // row
-      int_type ncols;
-      int_type colnums = matrix->n();
+      TrilinosWrapper::types::int_type ncols;
+      TrilinosWrapper::types::int_type colnums = matrix->n();
       if (value_cache.get() == 0)
         {
           value_cache.reset (new std::vector<TrilinosScalar> (matrix->n()));
@@ -68,10 +68,10 @@ namespace TrilinosWrappers
         }
 
       int ierr = matrix->trilinos_matrix().
-                 ExtractGlobalRowCopy((int_type)this->a_row,
+                 ExtractGlobalRowCopy((TrilinosWrapper::types::int_type)this->a_row,
                                       colnums,
                                       ncols, &((*value_cache)[0]),
-                                      reinterpret_cast<int_type *>(&((*colnum_cache)[0])));
+                                      reinterpret_cast<TrilinosWrapper::types::int_type *>(&((*colnum_cache)[0])));
       value_cache->resize (ncols);
       colnum_cache->resize (ncols);
       AssertThrow (ierr == 0, ExcTrilinosError(ierr));
@@ -116,7 +116,7 @@ namespace TrilinosWrappers
     :
     column_space_map (new Epetra_Map (input_map)),
     matrix (new Epetra_FECrsMatrix(Copy, *column_space_map,
-                                   int_type(n_max_entries_per_row), false)),
+                                   TrilinosWrapper::types::int_type(n_max_entries_per_row), false)),
     last_action (Zero),
     compressed (false)
   {}
@@ -129,7 +129,7 @@ namespace TrilinosWrappers
     column_space_map (new Epetra_Map (input_map)),
     matrix (new Epetra_FECrsMatrix
             (Copy, *column_space_map,
-             (int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
+             (TrilinosWrapper::types::int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
              false)),
     last_action (Zero),
     compressed (false)
@@ -143,7 +143,7 @@ namespace TrilinosWrappers
     :
     column_space_map (new Epetra_Map (input_col_map)),
     matrix (new Epetra_FECrsMatrix(Copy, input_row_map,
-                                   int_type(n_max_entries_per_row), false)),
+                                   TrilinosWrapper::types::int_type(n_max_entries_per_row), false)),
     last_action (Zero),
     compressed (false)
   {}
@@ -156,7 +156,7 @@ namespace TrilinosWrappers
     :
     column_space_map (new Epetra_Map (input_col_map)),
     matrix (new Epetra_FECrsMatrix(Copy, input_row_map,
-                                   (int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
+                                   (TrilinosWrapper::types::int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
                                    false)),
     last_action (Zero),
     compressed (false)
@@ -168,7 +168,7 @@ namespace TrilinosWrappers
                               const size_type n,
                               const size_type n_max_entries_per_row)
     :
-    column_space_map (new Epetra_Map (static_cast<int_type>(n), 0,
+    column_space_map (new Epetra_Map (static_cast<TrilinosWrapper::types::int_type>(n), 0,
                                       Utilities::Trilinos::comm_self())),
 
     // on one processor only, we know how the
@@ -180,7 +180,7 @@ namespace TrilinosWrappers
     // information from columns is only
     // available when entries have been added
     matrix (new Epetra_FECrsMatrix(Copy,
-                                   Epetra_Map (static_cast<int_type>(m), 0,
+                                   Epetra_Map (static_cast<TrilinosWrapper::types::int_type>(m), 0,
                                                Utilities::Trilinos::comm_self()),
                                    *column_space_map,
                                    n_max_entries_per_row,
@@ -195,13 +195,13 @@ namespace TrilinosWrappers
                               const size_type               n,
                               const std::vector<size_type> &n_entries_per_row)
     :
-    column_space_map (new Epetra_Map (static_cast<int_type>(n), 0,
+    column_space_map (new Epetra_Map (static_cast<TrilinosWrapper::types::int_type>(n), 0,
                                       Utilities::Trilinos::comm_self())),
     matrix (new Epetra_FECrsMatrix(Copy,
-                                   Epetra_Map (static_cast<int_type>(m), 0,
+                                   Epetra_Map (static_cast<TrilinosWrapper::types::int_type>(m), 0,
                                                Utilities::Trilinos::comm_self()),
                                    *column_space_map,
-                                   (int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
+                                   (TrilinosWrapper::types::int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
                                    false)),
     last_action (Zero),
     compressed (false)
@@ -233,7 +233,7 @@ namespace TrilinosWrappers
                                      make_trilinos_map(communicator, false))),
     matrix (new Epetra_FECrsMatrix(Copy,
                                    *column_space_map,
-                                   (int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
+                                   (TrilinosWrapper::types::int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
                                    false)),
     last_action (Zero),
     compressed (false)
@@ -269,7 +269,7 @@ namespace TrilinosWrappers
     matrix (new Epetra_FECrsMatrix(Copy,
                                    row_parallel_partitioning.
                                    make_trilinos_map(communicator, false),
-                                   (int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
+                                   (TrilinosWrapper::types::int_type *)const_cast<size_type *>(&(n_entries_per_row[0])),
                                    false)),
     last_action (Zero),
     compressed (false)
@@ -338,10 +338,10 @@ namespace TrilinosWrappers
   void
   SparseMatrix::reinit (const SparsityType &sparsity_pattern)
   {
-    const Epetra_Map rows (static_cast<int_type>(sparsity_pattern.n_rows()),
+    const Epetra_Map rows (static_cast<TrilinosWrapper::types::int_type>(sparsity_pattern.n_rows()),
                            0,
                            Utilities::Trilinos::comm_self());
-    const Epetra_Map columns (static_cast<int_type>(sparsity_pattern.n_cols()),
+    const Epetra_Map columns (static_cast<TrilinosWrapper::types::int_type>(sparsity_pattern.n_cols()),
                               0,
                               Utilities::Trilinos::comm_self());
 
@@ -370,7 +370,7 @@ namespace TrilinosWrappers
       template <typename Sparsity>
       void copy_row (const Sparsity        &csp,
                      const size_type        row,
-                     std::vector<int_type> &row_indices)
+                     std::vector<TrilinosWrapper::types::int_type> &row_indices)
       {
         typename Sparsity::row_iterator col_num = csp.row_begin (row);
         for (size_type col=0; col_num != csp.row_end (row); ++col_num, ++col)
@@ -379,7 +379,7 @@ namespace TrilinosWrappers
 
       void copy_row (const dealii::SparsityPattern &csp,
                      const size_int                 row,
-                     std::vector<int_type>         &row_indices)
+                     std::vector<TrilinosWrapper::types::int_type>         &row_indices)
       {
         dealii::SparsityPattern::iterator col_num = csp.begin (row);
         for (size_type col=0; col_num != csp.end (row); ++col_num, ++col)
@@ -428,7 +428,7 @@ namespace TrilinosWrappers
 
     const size_t first_row = input_row_map.MinMyGID(),
                        last_row = input_row_map.MaxMyGID()+1;
-    std::vector<int_type> n_entries_per_row(last_row-first_row);
+    std::vector<TrilinosWrapper::types::int_type> n_entries_per_row(last_row-first_row);
 
     for (size_type row=first_row; row<last_row; ++row)
       n_entries_per_row[row-first_row] = sparsity_pattern.row_length(row);
@@ -459,11 +459,11 @@ namespace TrilinosWrappers
     // distributed.
 
     // now insert the indices
-    std::vector<int_type>   row_indices;
+    std::vector<TrilinosWrapper::types::int_type>   row_indices;
 
     for (size_type row=first_row; row<last_row; ++row)
       {
-        const int_type row_length = sparsity_pattern.row_length(row);
+        const TrilinosWrapper::types::int_type row_length = sparsity_pattern.row_length(row);
         if (row_length == 0)
           continue;
 
@@ -531,10 +531,10 @@ namespace TrilinosWrappers
                         const bool                            copy_values,
                         const ::dealii::SparsityPattern      *use_this_sparsity)
   {
-    const Epetra_Map rows (static_cast<int_type>(dealii_sparse_matrix.m()),
+    const Epetra_Map rows (static_cast<TrilinosWrapper::types::int_type>(dealii_sparse_matrix.m()),
                            0,
                            Utilities::Trilinos::comm_self());
-    const Epetra_Map columns (static_cast<int_type>(dealii_sparse_matrix.n()),
+    const Epetra_Map columns (static_cast<TrilinosWrapper::types::int_type>(dealii_sparse_matrix.n()),
                               0,
                               Utilities::Trilinos::comm_self());
     reinit (rows, columns, dealii_sparse_matrix, drop_tolerance,
@@ -581,10 +581,10 @@ namespace TrilinosWrappers
 
     const size_type n_rows = dealii_sparse_matrix.m();
 
-    Assert (input_row_map.NumGlobalElements() == (int_type)n_rows,
+    Assert (input_row_map.NumGlobalElements() == (TrilinosWrapper::types::int_type)n_rows,
             ExcDimensionMismatch (input_row_map.NumGlobalElements(),
                                   n_rows));
-    Assert (input_col_map.NumGlobalElements() == (int_type)dealii_sparse_matrix.n(),
+    Assert (input_col_map.NumGlobalElements() == (TrilinosWrapper::types::int_type)dealii_sparse_matrix.n(),
             ExcDimensionMismatch (input_col_map.NumGlobalElements(),
                                   dealii_sparse_matrix.n()));
 
@@ -612,7 +612,7 @@ namespace TrilinosWrappers
 
     for (size_type row=0; row<n_rows; ++row)
       // see if the row is locally stored on this processor
-      if (input_row_map.MyGID(static_cast<int_type>(row)) == true)
+      if (input_row_map.MyGID(static_cast<TrilinosWrapper::types::int_type>(row)) == true)
         {
           ::dealii::SparsityPattern::iterator select_index =
             sparsity_pattern.begin(row);
@@ -720,23 +720,25 @@ namespace TrilinosWrappers
 
     // Only do this on the rows owned
     // locally on this processor.
-    int_type local_row = matrix->LRID(static_cast<int_type>(row));
+    TrilinosWrapper::types::int_type local_row = 
+      matrix->LRID(static_cast<TrilinosWrapper::types::int_type>(row));
     if (local_row >= 0)
       {
         TrilinosScalar *values;
-        int_type *col_indices;
-        int_type num_entries;
+        TrilinosWrapper::types::int_type *col_indices;
+        TrilinosWrapper::types::int_type num_entries;
         const int ierr = matrix->ExtractMyRowView(local_row, num_entries,
                                                   values, col_indices);
 
         Assert (ierr == 0,
                 ExcTrilinosError(ierr));
 
-        int_type *diag_find = std::find(col_indices,col_indices+num_entries,
-                                   local_row);
-        int_type diag_index = (int_type)(diag_find - col_indices);
+        TrilinosWrapper::types::int_type *diag_find = std::find(col_indices,
+            col_indices+num_entries,local_row);
+        TrilinosWrapper::types::int_type diag_index = 
+          (TrilinosWrapper::types::int_type)(diag_find - col_indices);
 
-        for (int_type j=0; j<num_entries; ++j)
+        for (TrilinosWrapper::types::int_type j=0; j<num_entries; ++j)
           if (diag_index != j || new_diag_value == 0)
             values[j] = 0.;
 
@@ -772,8 +774,8 @@ namespace TrilinosWrappers
   {
     // Extract local indices in
     // the matrix.
-    int_type trilinos_i = matrix->LRID(static_cast<int_type>(i)),
-             trilinos_j = matrix->LCID(static_cast<int_type>(j));
+    TrilinosWrapper::types::int_type trilinos_i = matrix->LRID(static_cast<TrilinosWrapper::types::int_type>(i)),
+                                     trilinos_j = matrix->LCID(static_cast<TrilinosWrapper::types::int_type>(j));
     TrilinosScalar value = 0.;
 
     // If the data is not on the
@@ -796,9 +798,9 @@ namespace TrilinosWrappers
 
         // Prepare pointers for extraction
         // of a view of the row.
-        int_type nnz_present = matrix->NumMyEntries(trilinos_i);
-        int_type nnz_extracted;
-        int_type *col_indices;
+        TrilinosWrapper::types::int_type nnz_present = matrix->NumMyEntries(trilinos_i);
+        TrilinosWrapper::types::int_type nnz_extracted;
+        TrilinosWrapper::types::int_type *col_indices;
         TrilinosScalar *values;
 
         // Generate the view and make
@@ -815,10 +817,11 @@ namespace TrilinosWrappers
         // look for the value, and then
         // finally get it.
 
-        int_type *el_find = std::find(col_indices, col_indices + nnz_present,
-                                 trilinos_j);
+        TrilinosWrapper::types::int_type *el_find = std::find(col_indices, 
+            col_indices + nnz_present, trilinos_j);
 
-        int_type local_col_index = (int_type)(el_find - col_indices);
+        TrilinosWrapper::types::int_type local_col_index = 
+          (TrilinosWrapper::types::int_type)(el_find - col_indices);
 
         // This is actually the only
         // difference to the el(i,j)
@@ -847,7 +850,9 @@ namespace TrilinosWrappers
   {
     // Extract local indices in
     // the matrix.
-    int_type trilinos_i = matrix->LRID(static_cast<int_type>(i)), trilinos_j = matrix->LCID(static_cast<int_type>(j));
+    TrilinosWrapper::types::int_type trilinos_i = 
+      matrix->LRID(static_cast<TrilinosWrapper::types::int_type>(i)), 
+      trilinos_j = matrix->LCID(static_cast<TrilinosWrapper::types::int_type>(j));
     TrilinosScalar value = 0.;
 
     // If the data is not on the
@@ -868,9 +873,9 @@ namespace TrilinosWrappers
 
         // Prepare pointers for extraction
         // of a view of the row.
-        int_type nnz_present = matrix->NumMyEntries(trilinos_i);
-        int_type nnz_extracted;
-        int_type *col_indices;
+        TrilinosWrapper::types::int_type nnz_present = matrix->NumMyEntries(trilinos_i);
+        TrilinosWrapper::types::int_type nnz_extracted;
+        TrilinosWrapper::types::int_type *col_indices;
         TrilinosScalar *values;
 
         // Generate the view and make
@@ -886,10 +891,11 @@ namespace TrilinosWrappers
         // Search the index where we
         // look for the value, and then
         // finally get it.
-        int_type *el_find = std::find(col_indices, col_indices + nnz_present,
-                                 trilinos_j);
+        TrilinosWrapper::types::int_type *el_find = std::find(col_indices, 
+            col_indices + nnz_present, trilinos_j);
 
-        int_type local_col_index = (int_type)(el_find - col_indices);
+        TrilinosWrapper::types::int_type local_col_index = 
+          (TrilinosWrapper::types::int_type)(el_find - col_indices);
 
 
         // This is actually the only
@@ -938,8 +944,9 @@ namespace TrilinosWrappers
 
     // get a representation of the
     // present row
-    int_type ncols = -1;
-    int_type local_row = matrix->LRID(static_cast<int_type>(row));
+    TrilinosWrapper::types::int_type ncols = -1;
+    TrilinosWrapper::types::int_type local_row = 
+      matrix->LRID(static_cast<TrilinosWrapper::types::int_type>(row));
 
     // on the processor who owns this
     // row, we'll have a non-negative
@@ -1005,15 +1012,15 @@ namespace TrilinosWrappers
                   ExcMessage ("Parallel distribution of matrix B and vector V "
                               "does not match."));
 
-          const int_type local_N = inputright.local_size();
-          for (int_type i=0; i<local_N; ++i)
+          const TrilinosWrapper::types::int_type local_N = inputright.local_size();
+          for (TrilinosWrapper::types::int_type i=0; i<local_N; ++i)
             {
-              int_type N_entries = -1;
+              TrilinosWrapper::types::int_type N_entries = -1;
               double *new_data, *B_data;
               mod_B->ExtractMyRowView (i, N_entries, new_data);
               inputright.trilinos_matrix().ExtractMyRowView (i, N_entries, B_data);
               double value = V.trilinos_vector()[0][i];
-              for (int_type j=0; j<N_entries; ++j)
+              for (TrilinosWrapper::types::int_type j=0; j<N_entries; ++j)
                 new_data[j] = value * B_data[j];
             }
         }
@@ -1048,12 +1055,12 @@ namespace TrilinosWrappers
                   ExcMessage("Matrix must be partitioned contiguously between procs."));
           for (size_type i=0; i<inputleft.local_size(); ++i)
             {
-              int_type num_entries, * indices;
+              TrilinosWrapper::types::int_type num_entries, * indices;
               inputleft.trilinos_sparsity_pattern().ExtractMyRowView(i, num_entries,
                                                                      indices);
               Assert (num_entries >= 0, ExcInternalError());
               const sizretype GID = inputleft.row_partitioner().GID(i);
-              for (int_type j=0; j<num_entries; ++j)
+              for (TrilinosWrapper::types::int_type j=0; j<num_entries; ++j)
                 sparsity_transposed.add (inputleft.col_partitioner().GID(indices[j]),
                                          GID);
             }
@@ -1062,13 +1069,13 @@ namespace TrilinosWrappers
           transposed_mat.reinit (sparsity_transposed);
           for (size_type i=0; i<inputleft.local_size(); ++i)
             {
-              int_type num_entries, * indices;
+              TrilinosWrapper::types::int_type num_entries, * indices;
               double *values;
               inputleft.trilinos_matrix().ExtractMyRowView(i, num_entries,
                                                            values, indices);
               Assert (num_entries >= 0, ExcInternalError());
               const size_type GID = inputleft.row_partitioner().GID(i);
-              for (int_type j=0; j<num_entries; ++j)
+              for (TrilinosWrapper::types::int_type j=0; j<num_entries; ++j)
                 transposed_mat.set (inputleft.col_partitioner().GID(indices[j]),
                                     GID, values[j]);
             }
@@ -1089,12 +1096,12 @@ namespace TrilinosWrappers
       // import data if necessary
       ML_Operator *Btmp, *Ctmp, *Ctmp2, *tptr;
       ML_CommInfoOP *getrow_comm;
-      int_type max_per_proc;
-      int_type N_input_vector = B_->invec_leng;
+      TrilinosWrapper::types::int_type max_per_proc;
+      TrilinosWrapper::types::int_type N_input_vector = B_->invec_leng;
       getrow_comm = B_->getrow->pre_comm;
       if ( getrow_comm != NULL)
-        for (int_type i = 0; i < getrow_comm->N_neighbors; i++)
-          for (int_type j = 0; j < getrow_comm->neighbors[i].N_send; j++)
+        for (TrilinosWrapper::types::int_type i = 0; i < getrow_comm->N_neighbors; i++)
+          for (TrilinosWrapper::types::int_type j = 0; j < getrow_comm->neighbors[i].N_send; j++)
             AssertThrow (getrow_comm->neighbors[i].send_list[j] < N_input_vector,
                          ExcInternalError());
 
@@ -1213,8 +1220,9 @@ namespace TrilinosWrappers
                   ExcDimensionMismatch(matrix->NumGlobalEntries(row),
                                        rhs.matrix->NumGlobalEntries(row)));
 
-          const int_type row_local = matrix->RowMap().LID(static_cast<int_type>(row));
-          int_type n_entries, rhs_n_entries;
+          const TrilinosWrapper::types::int_type row_local = 
+            matrix->RowMap().LID(static_cast<TrilinosWrapper::types::int_type>(row));
+          TrilinosWrapper::types::int_type n_entries, rhs_n_entries;
           TrilinosScalar *value_ptr, *rhs_value_ptr;
 
           // In debug mode, we want to check
@@ -1226,7 +1234,7 @@ namespace TrilinosWrappers
           // indices is relatively slow compared to
           // just working with the values.
 #ifdef DEBUG
-          int_type *index_ptr, *rhs_index_ptr;
+          TrilinosWrapper::types::int_type *index_ptr, *rhs_index_ptr;
           ierr = rhs.matrix->ExtractMyRowView (row_local, rhs_n_entries,
                                                rhs_value_ptr, rhs_index_ptr);
           Assert (ierr == 0, ExcTrilinosError(ierr));
@@ -1242,7 +1250,7 @@ namespace TrilinosWrappers
           AssertThrow (n_entries == rhs_n_entries,
                        ExcDimensionMismatch (n_entries, rhs_n_entries));
 
-          for (int_type i=0; i<n_entries; ++i)
+          for (TrilinosWrapper::types::int_type i=0; i<n_entries; ++i)
             {
               *value_ptr++ += *rhs_value_ptr++ * factor;
 #ifdef DEBUG
@@ -1267,7 +1275,7 @@ namespace TrilinosWrappers
             = std::max (max_row_length,
                         static_cast<size_type>(rhs.matrix->NumGlobalEntries(row)));
 
-        std::vector<int_type>       column_indices (max_row_length);
+        std::vector<TrilinosWrapper::types::int_type> column_indices (max_row_length);
         std::vector<TrilinosScalar> values (max_row_length);
 
         if (matrix->Filled() == true && rhs.matrix->Filled() == true &&
@@ -1275,8 +1283,9 @@ namespace TrilinosWrappers
           for (size_type row=local_range.first;
                row < local_range.second; ++row)
             {
-              const int_type row_local = matrix->RowMap().LID(static_cast<int_type>(row));
-              int_type n_entries;
+              const TrilinosWrapper::types::int_type row_local = 
+                matrix->RowMap().LID(static_cast<TrilinosWrapper::types::int_type>(row));
+              TrilinosWrapper::types::int_type n_entries;
 
               ierr = rhs.matrix->ExtractMyRowCopy (row_local, max_row_length,
                                                    n_entries,
@@ -1284,7 +1293,7 @@ namespace TrilinosWrappers
                                                    &column_indices[0]);
               Assert (ierr == 0, ExcTrilinosError(ierr));
 
-              for (int_type i=0; i<n_entries; ++i)
+              for (TrilinosWrapper::types::int_type i=0; i<n_entries; ++i)
                 values[i] *= factor;
 
               TrilinosScalar *value_ptr = &values[0];
@@ -1298,16 +1307,18 @@ namespace TrilinosWrappers
             for (size_type row=local_range.first;
                  row < local_range.second; ++row)
               {
-                int_type n_entries;
+                TrilinosWrapper::types::int_type n_entries;
                 ierr = rhs.matrix->Epetra_CrsMatrix::ExtractGlobalRowCopy
-                       ((int_type)row, max_row_length, n_entries, &values[0], &column_indices[0]);
+                       ((TrilinosWrapper::types::int_type)row, max_row_length, 
+                        n_entries, &values[0], &column_indices[0]);
                 Assert (ierr == 0, ExcTrilinosError(ierr));
 
-                for (int_type i=0; i<n_entries; ++i)
+                for (TrilinosWrapper::types::int_type i=0; i<n_entries; ++i)
                   values[i] *= factor;
 
                 ierr = matrix->Epetra_CrsMatrix::SumIntoGlobalValues
-                       ((int_type)row, n_entries, &values[0], &column_indices[0]);
+                       ((TrilinosWrapper::types::int_type)row, n_entries, 
+                        &values[0], &column_indices[0]);
                 Assert (ierr == 0, ExcTrilinosError(ierr));
               }
             compress ();
@@ -1362,13 +1373,13 @@ namespace TrilinosWrappers
     else
       {
         double *values;
-        int_type *indices;
-        int_type num_entries;
+        TrilinosWrapper::types::int_type *indices;
+        TrilinosWrapper::types::int_type num_entries;
 
-        for (int_type i=0; i<matrix->NumMyRows(); ++i)
+        for (TrilinosWrapper::types::int_type i=0; i<matrix->NumMyRows(); ++i)
           {
             matrix->ExtractMyRowView (i, num_entries, values, indices);
-            for (int_type j=0; j<num_entries; ++j)
+            for (TrilinosWrapper::types::int_type j=0; j<num_entries; ++j)
               out << "(" << matrix->GRID(i) << "," << matrix->GCID(indices[j]) << ") "
                   << values[j] << std::endl;
           }
@@ -1384,9 +1395,8 @@ namespace TrilinosWrappers
   {
     size_type static_memory = sizeof(this) + sizeof (*matrix)
                                  + sizeof(*matrix->Graph().DataPtr());
-    return ((sizeof(TrilinosScalar)+sizeof(int_type))*matrix->NumMyNonzeros() +
-            sizeof(int)*local_size() +
-            static_memory);
+    return ((sizeof(TrilinosScalar)+sizeof(TrilinosWrapper::types::int_type))*
+        matrix->NumMyNonzeros() + sizeof(int)*local_size() + static_memory);
   }
 
 
index fc68eddba064581d118bfcbd48f6e081f5dc9dff..cea1e9f5cd7a9d992cdf86cd27ff4728c67e8119 100644 (file)
@@ -48,14 +48,14 @@ namespace TrilinosWrappers
 
       // get a representation of the present
       // row
-      int_type ncols;
-      int_type colnums = sparsity_pattern->n_cols();
+      TrilinosWrapper::types::int_type ncols;
+      TrilinosWrapper::types::int_type colnums = sparsity_pattern->n_cols();
 
       int ierr;
-      ierr = sparsity_pattern->graph->ExtractGlobalRowCopy((int_type)this->a_row,
+      ierr = sparsity_pattern->graph->ExtractGlobalRowCopy((TrilinosWrapper::types::int_type)this->a_row,
                                                            colnums,
                                                            ncols,
-                                                           (int_type *)&(*colnum_cache)[0]);
+                                                           (TrilinosWrapper::types::int_type *)&(*colnum_cache)[0]);
       AssertThrow (ierr == 0, ExcTrilinosError(ierr));
 
       // copy it into our caches if the
@@ -177,8 +177,8 @@ namespace TrilinosWrappers
                            const size_type  n,
                            const size_type  n_entries_per_row)
   {
-    const Epetra_Map rows (static_cast<int_type>(m), 0, Utilities::Trilinos::comm_self());
-    const Epetra_Map columns (static_cast<int_type>(n), 0, Utilities::Trilinos::comm_self());
+    const Epetra_Map rows (static_cast<TrilinosWrapper::types::int_type>(m), 0, Utilities::Trilinos::comm_self());
+    const Epetra_Map columns (static_cast<TrilinosWrapper::types::int_type>(n), 0, Utilities::Trilinos::comm_self());
 
     reinit (rows, columns, n_entries_per_row);
   }
@@ -227,8 +227,10 @@ namespace TrilinosWrappers
                            const size_type  n,
                            const std::vector<size_type> &n_entries_per_row)
   {
-    const Epetra_Map rows (static_cast<int_type>(m), 0, Utilities::Trilinos::comm_self());
-    const Epetra_Map columns (static_cast<int_type>(n), 0, Utilities::Trilinos::comm_self());
+    const Epetra_Map rows (static_cast<TrilinosWrapper::types::int_type>(m), 0, 
+        Utilities::Trilinos::comm_self());
+    const Epetra_Map columns (static_cast<TrilinosWrapper::types::int_type>(n), 0, 
+        Utilities::Trilinos::comm_self());
 
     reinit (rows, columns, n_entries_per_row);
   }
@@ -238,7 +240,7 @@ namespace TrilinosWrappers
   void
   SparsityPattern::reinit (const Epetra_Map   &input_row_map,
                            const Epetra_Map   &input_col_map,
-                           const std::vector<int_type> &n_entries_per_row)
+                           const std::vector<TrilinosWrapper::types::int_type> &n_entries_per_row)
   {
     // release memory before reallocation
     graph.reset ();
@@ -280,7 +282,7 @@ namespace TrilinosWrappers
       template <typename Sparsity>
       void copy_row (const Sparsity     &csp,
                      const size_type     row,
-                     std::vector<int_type>   &row_indices)
+                     std::vector<TrilinosWrapper::types::int_type>   &row_indices)
       {
         typename Sparsity::row_iterator col_num = csp.row_begin (row);
         for (size_type col=0; col_num != csp.row_end (row); ++col_num, ++col)
@@ -289,7 +291,7 @@ namespace TrilinosWrappers
 
       void copy_row (const dealii::SparsityPattern &csp,
                      const size_type                row,
-                     std::vector<int_type>          &row_indices)
+                     std::vector<TrilinosWrapper::types::int_type>          &row_indices)
       {
         dealii::SparsityPattern::iterator col_num = csp.begin (row);
         for (size_type col=0; col_num != csp.end (row); ++col_num, ++col)
@@ -322,7 +324,7 @@ namespace TrilinosWrappers
 
     const size_type first_row = input_row_map.MinMyGID(),
                        last_row = input_row_map.MaxMyGID()+1;
-    std::vector<int_type> n_entries_per_row(last_row - first_row);
+    std::vector<TrilinosWrapper::type::int_type> n_entries_per_row(last_row - first_row);
 
     for (size_type row=first_row; row<last_row; ++row)
       n_entries_per_row[row-first_row] = sp.row_length(row);
@@ -339,7 +341,7 @@ namespace TrilinosWrappers
     AssertDimension (sp.n_rows(),
                      static_cast<size_type>(graph->NumGlobalRows()));
 
-    std::vector<int_type> row_indices;
+    std::vector<TrilinosWrapper::types::int_type> row_indices;
 
     // Include possibility to exchange data
     // since CompressedSimpleSparsityPattern is
@@ -347,7 +349,7 @@ namespace TrilinosWrappers
     if (exchange_data==false)
       for (size_type row=first_row; row<last_row; ++row)
         {
-          const int_type row_length = sp.row_length(row);
+          const TrilinosWrapper::types::int_type row_length = sp.row_length(row);
           if (row_length == 0)
             continue;
 
@@ -359,13 +361,14 @@ namespace TrilinosWrappers
     else
       for (size_type row=0; row<sp.n_rows(); ++row)
         {
-          const int_type row_length = sp.row_length(row);
+          const TrilinosWrapper::types::int_type row_length = sp.row_length(row);
           if (row_length == 0)
             continue;
 
           row_indices.resize (row_length, -1);
           internal::copy_row(sp, row, row_indices);
-          graph->InsertGlobalIndices (1, reinterpret_cast<int_type *>(&row),
+          graph->InsertGlobalIndices (1, 
+                                      reinterpret_cast<TrilinosWrapper::types::int_type *>(&row),
                                       row_length, &row_indices[0]);
         }
 
@@ -387,8 +390,8 @@ namespace TrilinosWrappers
   void
   SparsityPattern::copy_from (const SparsityType &sp)
   {
-    const Epetra_Map rows (static_cast<int_type>(sp.n_rows()), 0, Utilities::Trilinos::comm_self());
-    const Epetra_Map columns (static_cast<int_type>(sp.n_cols()), 0, Utilities::Trilinos::comm_self());
+    const Epetra_Map rows (static_cast<TrilinosWrapper::types::int_type>(sp.n_rows()), 0, Utilities::Trilinos::comm_self());
+    const Epetra_Map columns (static_cast<TrilinosWrapper::types::int_type>(sp.n_cols()), 0, Utilities::Trilinos::comm_self());
 
     reinit (rows, columns, sp);
   }
@@ -436,7 +439,9 @@ namespace TrilinosWrappers
   {
     // Extract local indices in
     // the matrix.
-    int_type trilinos_i = graph->LRID(static_cast<int_type>(i)), trilinos_j = graph->LCID(static_cast<int_type>(j));
+    TrilinosWrapper::types::int_type trilinos_i = 
+      graph->LRID(static_cast<TrilinosWrapper::types::int_type>(i)), 
+      trilinos_j = graph->LCID(static_cast<TrilinosWrapper::types::int_type>(j));
 
     // If the data is not on the
     // present processor, we throw
@@ -455,9 +460,9 @@ namespace TrilinosWrappers
         // local indices.
         if (graph->Filled() == false)
           {
-            int_type nnz_present = graph->NumGlobalIndices(i);
-            int_type nnz_extracted;
-            int_type *col_indices;
+            TrilinosWrapper::types::int_type nnz_present = graph->NumGlobalIndices(i);
+            TrilinosWrapper::types::int_type nnz_extracted;
+            TrilinosWrapper::types::int_type *col_indices;
 
             // Generate the view and make
             // sure that we have not generated
@@ -469,10 +474,11 @@ namespace TrilinosWrappers
                     ExcDimensionMismatch(nnz_present, nnz_extracted));
 
             // Search the index
-            int_type *el_find = std::find(col_indices, col_indices + nnz_present,
-                                     trilinos_j);
+            TrilinosWrapper::types::int_type *el_find = 
+              std::find(col_indices, col_indices + nnz_present, trilinos_j);
 
-            int_type local_col_index = (int_type)(el_find - col_indices);
+            TrilinosWrapper::types::int_type local_col_index = 
+              (TrilinosWrapper::types::int_type)(el_find - col_indices);
 
             if (local_col_index == nnz_present)
               return false;
@@ -481,9 +487,9 @@ namespace TrilinosWrappers
           {
             // Prepare pointers for extraction
             // of a view of the row.
-            int_type nnz_present = graph->NumGlobalIndices(i);
-            int_type nnz_extracted;
-            int_type *col_indices;
+            TrilinosWrapper::types::int_type nnz_present = graph->NumGlobalIndices(i);
+            TrilinosWrapper::types::int_type nnz_extracted;
+            TrilinosWrapper::types::int_type *col_indices;
 
             // Generate the view and make
             // sure that we have not generated
@@ -496,10 +502,11 @@ namespace TrilinosWrappers
                     ExcDimensionMismatch(nnz_present, nnz_extracted));
 
             // Search the index
-            int_type *el_find = std::find(col_indices, col_indices + nnz_present,
-                                     trilinos_j);
+            TrilinosWrapper::types::int_type *el_find = std::find(col_indices, 
+                col_indices + nnz_present, trilinos_j);
 
-            int_type local_col_index = (int_type)(el_find - col_indices);
+            TrilinosWrapper::types::int_type local_col_index = 
+              (TrilinosWrapper::types::int_type)(el_find - col_indices);
 
             if (local_col_index == nnz_present)
               return false;
@@ -515,11 +522,11 @@ namespace TrilinosWrappers
   SparsityPattern::bandwidth () const
   {
     size_type local_b=0;
-    int_type global_b=0;
+    TrilinosWrapper::types::int_type global_b=0;
     for (size_type i=0; i<local_size(); ++i)
       {
-        int_type *indices;
-        int_type num_entries;
+        TrilinosWrapper::types::int_type *indices;
+        TrilinosWrapper::types::int_type num_entries;
         graph->ExtractMyRowView(i, num_entries, indices);
         for (size_type j=0; j<(size_type)num_entries; ++j)
           {
@@ -527,7 +534,7 @@ namespace TrilinosWrappers
               local_b = std::abs(static_cast<size_type>(i-indices[j]));
           }
       }
-    graph->Comm().MaxAll((int_type *)&local_b, &global_b, 1);
+    graph->Comm().MaxAll((TrilinosWrapper::types::int_type *)&local_b, &global_b, 1);
     return static_cast<size_type>(global_b);
   }
 
@@ -536,7 +543,7 @@ namespace TrilinosWrappers
   size_type
   SparsityPattern::n_rows () const
   {
-    const int_type n_rows = graph -> NumGlobalRows();
+    const TrilinosWrapper::types::int_type n_rows = graph -> NumGlobalRows();
     return n_rows;
   }
 
@@ -545,7 +552,7 @@ namespace TrilinosWrappers
   size_type
   SparsityPattern::n_cols () const
   {
-    int_type n_cols;
+    TrilinosWrapper::types::int_type n_cols;
     if (graph->Filled() == true)
       n_cols = graph -> NumGlobalCols();
     else
@@ -559,7 +566,7 @@ namespace TrilinosWrappers
   size_type
   SparsityPattern::local_size () const
   {
-    int_type n_rows = graph -> NumMyRows();
+    TrilinosWrapper::types::int_type n_rows = graph -> NumMyRows();
 
     return n_rows;
   }
@@ -581,7 +588,7 @@ namespace TrilinosWrappers
   size_type
   SparsityPattern::n_nonzero_elements () const
   {
-    int_type nnz = graph->NumGlobalEntries();
+    TrilinosWrapper::types::int_type nnz = graph->NumGlobalEntries();
 
     return static_cast<size_type>(nnz);
   }
@@ -591,7 +598,7 @@ namespace TrilinosWrappers
   size_type
   SparsityPattern::max_entries_per_row () const
   {
-    int_type nnz = graph->MaxNumIndices();
+    TrilinosWrapper::types::int_type nnz = graph->MaxNumIndices();
 
     return static_cast<size_type>(nnz);
   }
@@ -605,8 +612,9 @@ namespace TrilinosWrappers
 
     // get a representation of the
     // present row
-    int_type ncols = -1;
-    int_type local_row = graph->LRID(static_cast<int_type>(row));
+    TrilinosWrapper::types::int_type ncols = -1;
+    TrilinosWrapper::types::int_type local_row = 
+      graph->LRID(static_cast<TrilinosWrapper::types::int_type>(row));
 
     // on the processor who owns this
     // row, we'll have a non-negative
@@ -638,13 +646,13 @@ namespace TrilinosWrappers
       out << *graph;
     else
       {
-        int_type *indices;
-        int_type num_entries;
+        TrilinosWrapper::types::int_type *indices;
+        TrilinosWrapper::types::int_type num_entries;
 
-        for (int_type i=0; i<graph->NumMyRows(); ++i)
+        for (TrilinosWrapper::types::int_type i=0; i<graph->NumMyRows(); ++i)
           {
             graph->ExtractMyRowView (i, num_entries, indices);
-            for (int_type j=0; j<num_entries; ++j)
+            for (TrilinosWrapper::types::int_type j=0; j<num_entries; ++j)
               out << "(" << i << "," << indices[graph->GRID(j)] << ") "
                   << std::endl;
           }
@@ -661,8 +669,8 @@ namespace TrilinosWrappers
     Assert (graph->Filled() == true, ExcInternalError());
     for (size_type row=0; row<local_size(); ++row)
       {
-        signed int_type *indices;
-        int_type num_entries;
+        signed TrilinosWrapper::types::int_type *indices;
+        TrilinosWrapper::types::int_type num_entries;
         graph->ExtractMyRowView (row, num_entries, indices);
 
         for (size_type j=0; j<(size_type)num_entries; ++j)
@@ -671,8 +679,9 @@ namespace TrilinosWrappers
           // j horizontal, gnuplot output is
           // x-y, that is we have to exchange
           // the order of output
-          out << indices[graph->GRID(static_cast<int_type>(j))] << " " << -static_cast<signed int_type>(row)
-              << std::endl;
+          out << indices[graph->GRID(static_cast<TrilinosWrapper::types::int_type>(j))]
+            << " " << -static_cast<signed TrilinosWrapper::types::int_type>(row)
+            << std::endl;
       }
 
     AssertThrow (out, ExcIO());
index 7b73a08247c24511f607e92f6d4d61824d8441a0..ac53f93a9221dac2f447028ea38b38b919e7ed0c 100644 (file)
@@ -231,10 +231,10 @@ namespace TrilinosWrappers
       size_type n_elements = 0, added_elements = 0, block_offset = 0;
       for (size_type block=0; block<v.n_blocks(); ++block)
         n_elements += v.block(block).local_size();
-      std::vector<int_type> global_ids (n_elements, -1);
+      std::vector<TrilinosWrapper::types::int_type> global_ids (n_elements, -1);
       for (size_type block=0; block<v.n_blocks(); ++block)
         {
-          int_type *glob_elements = 
+          TrilinosWrapper::types::int_type *glob_elements = 
             v.block(block).vector_partitioner().MyGlobalElements();
           for (size_type i=0; i<v.block(block).local_size(); ++i)
             global_ids[added_elements++] = glob_elements[i] + block_offset;
@@ -377,7 +377,7 @@ namespace TrilinosWrappers
   Vector::Vector (const size_type n)
   {
     last_action = Zero;
-    Epetra_LocalMap map ((int_type)n, 0, Utilities::Trilinos::comm_self());
+    Epetra_LocalMap map ((TrilinosWrapper::types::int_type)n, 0, Utilities::Trilinos::comm_self());
     vector.reset (new Epetra_FEVector (map));
   }
 
@@ -398,7 +398,7 @@ namespace TrilinosWrappers
                   const MPI_Comm &communicator)
   {
     last_action = Zero;
-    Epetra_LocalMap map (static_cast<int_type>(partitioning.size()),
+    Epetra_LocalMap map (static_cast<TrilinosWrapper::types::int_type>(partitioning.size()),
                          0,
 #ifdef DEAL_II_COMPILER_SUPPORTS_MPI
                          Epetra_MpiComm(communicator));
@@ -437,7 +437,7 @@ namespace TrilinosWrappers
   {
     if (size() != n)
       {
-        Epetra_LocalMap map ((int_type)n, 0,
+        Epetra_LocalMap map ((TrilinosWrapper::types::int_type)n, 0,
                              Utilities::Trilinos::comm_self());
         vector.reset (new Epetra_FEVector (map));
       }
@@ -488,9 +488,9 @@ namespace TrilinosWrappers
                   const bool      fast)
   {
     if (vector->Map().NumGlobalElements() !=
-        static_cast<int_type>(partitioning.size()))
+        static_cast<TrilinosWrapper::types::int_type>(partitioning.size()))
       {
-        Epetra_LocalMap map (static_cast<int_type>(partitioning.size()),
+        Epetra_LocalMap map (static_cast<TrilinosWrapper::types::int_type>(partitioning.size()),
                              0,
 #ifdef DEAL_II_COMPILER_SUPPORTS_MPI
                              Epetra_MpiComm(communicator));
index 255d72f7a59852f8599482750f9916368b1316e2..8f2bc2e0acd2f50d8a50add99156c58ee4e8af5f 100644 (file)
@@ -40,8 +40,8 @@ namespace TrilinosWrappers
       // we can use []. Note that we
       // can only get local values.
 
-      const int_type local_index = 
-        vector.vector->Map().LID(static_cast<int_type>(index));
+      const TrilinosWrapper::types::int_type local_index = 
+        vector.vector->Map().LID(static_cast<TrilinosWrapper::types::int_type>(index));
       Assert (local_index >= 0,
               ExcAccessToNonLocalElement (index,
                                           vector.vector->Map().MinMyGID(),
@@ -168,7 +168,8 @@ namespace TrilinosWrappers
   {
     // Extract local indices in
     // the vector.
-    int_type trilinos_i = vector->Map().LID(static_cast<int_type>(index));
+    TrilinosWrapper::types::int_type trilinos_i = 
+      vector->Map().LID(static_cast<TrilinosWrapper::types::int_type>(index));
     TrilinosScalar value = 0.;
 
     // If the element is not
@@ -196,7 +197,8 @@ namespace TrilinosWrappers
   {
     // Extract local indices in
     // the vector.
-    int_type trilinos_i = vector->Map().LID(static_cast<int_type>(index));
+    TrilinosWrapper::types::int_type trilinos_i = 
+      vector->Map().LID(static_cast<TrilinosWrapper::types::int_type>(index));
     TrilinosScalar value = 0.;
 
     // If the element is not present
@@ -423,7 +425,8 @@ namespace TrilinosWrappers
     //one index and the value per local
     //entry.
     return sizeof(*this)
-           + this->local_size()*( sizeof(double)+sizeof(int_type) );
+           + this->local_size()*( sizeof(double)+
+               sizeof(TrilinosWrapper::types::int_type) );
   }
 
 } /* end of namespace TrilinosWrappers */

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.