]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Merge from mainline.
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 21 Feb 2013 15:56:11 +0000 (15:56 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 21 Feb 2013 15:56:11 +0000 (15:56 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28510 0785d39b-7218-0410-832d-ea1e28bc413d

14 files changed:
1  2 
deal.II/examples/step-42/step-42.cc
deal.II/include/deal.II/dofs/dof_accessor.h
deal.II/include/deal.II/fe/fe_values.h
deal.II/include/deal.II/lac/arpack_solver.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/petsc_matrix_base.h
deal.II/include/deal.II/lac/petsc_parallel_block_vector.h
deal.II/include/deal.II/lac/petsc_parallel_vector.h
deal.II/include/deal.II/lac/petsc_vector_base.h
deal.II/include/deal.II/lac/precondition.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/vector.h
deal.II/source/lac/petsc_matrix_base.cc

Simple merge
index 066915fba144a95f037a5778dbeb9ff524f9a049,55735bd088fa0bd9b5d5db984273feea6e583a1a..03f0d9e59d8cf9b06ecbe540b4513127ee462656
@@@ -2137,7 -2140,8 +2137,8 @@@ public
     *
     * @deprecated Currently, this function can also be called for non-active cells, if all degrees of freedom of the FiniteElement are located in vertices. This functionality will vanish in a future release.
     */
 -  void get_dof_indices (std::vector<unsigned int> &dof_indices) const;
 +  void get_dof_indices (std::vector<types::global_dof_index> &dof_indices) const;
    /**
     * @deprecated Use get_active_or_mg_dof_indices() with level_cell_iterator returned from begin_mg().
     *
index b675d0e70d1287a16f7faec4f7237070a4d7ebcf,fd3abf17c28532efbaede4b5ac97ead202044d72..5ab4430dfb87ce2ffe10f8b92db49949379ebba6
@@@ -495,11 -489,9 +495,9 @@@ void ArpackSolver::solve 
        AssertDimension (eigenvalues.size(), eigenvalues_real.size());
        AssertDimension (eigenvalues.size(), eigenvalues_im.size());
  
 -      for (unsigned int i=0; i<eigenvalues.size(); ++i)
 +      for (size_type i=0; i<eigenvalues.size(); ++i)
-         {
-           eigenvalues[i].real() = eigenvalues_real[i];
-           eigenvalues[i].imag() = eigenvalues_im[i];
-         }
+       eigenvalues[i] = std::complex<double> (eigenvalues_real[i],
+                                              eigenvalues_im[i]);
      }
  }
  
index 88192e1ae707b51caf77396f6c1a606f0e8145b4,3c5587a6abd008f5060e943aa714f67872ae5676..92586f5ed60ae5b267366ea0cbc4c625a3d58ef0
@@@ -122,10 -122,17 +122,17 @@@ namespace PETScWrapper
         * <tt>local_elements[i]</tt>
         * elements on the present process.
         */
 -      BlockVector (const std::vector<unsigned int> &block_sizes,
 -                   const MPI_Comm                  &communicator,
 -                   const std::vector<unsigned int> &local_elements);
 +      BlockVector (const std::vector<size_type> &block_sizes,
 +                   const MPI_Comm               &communicator,
 +                   const std::vector<size_type> &local_elements);
  
+       /**
+        * Create a BlockVector with parallel_partitioning.size() blocks,
+        * each initialized with the given IndexSet.
+        */
+       explicit BlockVector (const std::vector<IndexSet> &parallel_partitioning,
+                             const MPI_Comm &communicator = MPI_COMM_WORLD);
        /**
         * Destructor. Clears memory
         */
index a707d97f2fb444d25c2906acc1109ed4a352ad5b,a6b8a92cbeaeb472c7fa6fb7f3a3584669558f4f..489d5f37a71bac4e189ed4b90a2231ea013de160
@@@ -146,7 -146,7 +146,7 @@@ namespace TrilinosWrapper
       * fill appropriate data using a
       * reinit of the blocks.
       */
-     BlockVector (const size_type num_blocks);
 -    explicit BlockVector (const unsigned int num_blocks);
++    explicit BlockVector (const size_type num_blocks);
  
      /**
       * Constructor. Set the number of
       *
       * References BlockVector.reinit().
       */
-     BlockVector (const std::vector<size_type> &N);
 -    explicit BlockVector (const std::vector<unsigned int> &N);
++    explicit BlockVector (const std::vector<size_type> &N);
  
      /**
       * Constructor. Set the number of
index 8ad150cebc8817d1645b5f17f0d750cb3b88d75b,7d7309d29d8e59d6ca25b5fecf5d8264254d2360..12ca9794db11046d53a4e359e0d1c3a45581dacd
@@@ -140,7 -140,7 +140,7 @@@ namespace TrilinosWrapper
         * fill appropriate data using a
         * reinit of the blocks.
         */
-       BlockVector (const size_type num_blocks);
 -      explicit BlockVector (const unsigned int num_blocks);
++      explicit BlockVector (const size_type num_blocks);
  
        /**
         * Destructor. Clears memory
Simple merge

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.