]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Merge from mainline.
authorBruno Turcksin <bruno.turcksin@gmail.com>
Fri, 26 Apr 2013 13:56:50 +0000 (13:56 +0000)
committerBruno Turcksin <bruno.turcksin@gmail.com>
Fri, 26 Apr 2013 13:56:50 +0000 (13:56 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@29388 0785d39b-7218-0410-832d-ea1e28bc413d

13 files changed:
1  2 
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/lac/full_matrix.h
deal.II/include/deal.II/lac/slepc_solver.h
deal.II/include/deal.II/lac/sparse_direct.h
deal.II/include/deal.II/matrix_free/fe_evaluation.h
deal.II/include/deal.II/matrix_free/matrix_free.h
deal.II/source/lac/petsc_vector_base.cc
deal.II/source/lac/slepc_solver.cc
deal.II/source/lac/sparse_direct.cc
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/mpi/matrix_free_01.cc
tests/mpi/matrix_free_03.cc

index e3f79df034dc45a4ac747e18ce58c8f0609f7da9,7a01b5127ac799c15bc65e9afc18899565d1ae56..b1e680217d1c137026df7f8846331511025fafd1
@@@ -1855,12 -1849,24 +1857,24 @@@ FullMatrix<number>::print (STREA
  {
    Assert (!this->empty(), ExcEmptyMatrix());
  
 -  for (unsigned int i=0; i<this->m(); ++i)
+   // save the state of out stream
+   const unsigned int old_precision = s.precision (p);
+   const unsigned int old_width = s.width (w);
 +  for (size_type i=0; i<this->m(); ++i)
      {
 -      for (unsigned int j=0; j<this->n(); ++j)
 +      for (size_type j=0; j<this->n(); ++j)
-         s << std::setw(w) << std::setprecision(p) << this->el(i,j);
+       {
+         s.width(w);
+         s.precision(p);
+         s << this->el(i,j);
+       }
        s << std::endl;
      }
+   // reset output format
+   s.precision(old_precision);
+   s.width(old_width);
  }
  
  
index d8c5ebad0d40dd77f3a57b64dd1ff46f56327fa3,595843a5d08320d6f17bd17fda43d599d5bab77a..765ebfa81669fbeea09aded4c4f9ef09f30ac0a9
@@@ -159,23 -165,8 +169,8 @@@ namespace SLEPcWrapper
             const PETScWrappers::MatrixBase &B,
             std::vector<double>             &kr,
             std::vector<OutputVector>       &vr,
 -           const unsigned int               n_eigenvectors = 1);
 +           const size_type                  n_eigenvectors = 1);
  
-     /**
-      * Initialize solver for the linear system $Ax=\lambda x$. (Note:
-      * this is required before calling solve ())
-      */
-     void
-     set_matrices (const PETScWrappers::MatrixBase &A);
-     /**
-      * Same as above, but here initialize solver for the linear system
-      * $A x=\lambda B x$.
-      */
-     void
-     set_matrices (const PETScWrappers::MatrixBase &A,
-                   const PETScWrappers::MatrixBase &B);
      /**
       * Set the initial vector for the solver.
       */
      // Panic if no eigenpairs are wanted.
      AssertThrow (n_eigenvectors != 0, ExcSLEPcWrappersUsageError());
  
 -    unsigned int n_converged = 0;
 +    size_type n_converged = 0;
  
      // Set the matrices of the problem
-     set_matrices (A);
+     set_matrices (A); 
  
      // and solve
      solve (n_eigenvectors, &n_converged);
  
    template <typename OutputVector>
    void
++<<<<<<< .working
 +  SolverBase::solve (const PETScWrappers::MatrixBase &A,
 +                     const PETScWrappers::MatrixBase &B,
 +                     std::vector<double>             &kr,
 +                     std::vector<OutputVector>       &vr,
 +                     const size_type                  n_eigenvectors)
++=======
+     SolverBase::solve (const PETScWrappers::MatrixBase &A,
+                      const PETScWrappers::MatrixBase &B,
+                      std::vector<double>             &kr,
+                      std::vector<OutputVector>       &vr,
+                      const unsigned int               n_eigenvectors)
++>>>>>>> .merge-right.r29387
    {
      // Panic if no eigenpairs are wanted.
      AssertThrow (n_eigenvectors != 0, ExcSLEPcWrappersUsageError());
Simple merge
Simple merge
Simple merge
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.