]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Don't try to work on parallel vectors and matrices.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 4 Apr 2004 23:32:02 +0000 (23:32 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 4 Apr 2004 23:32:02 +0000 (23:32 +0000)
git-svn-id: https://svn.dealii.org/trunk@8964 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/numerics/matrices.h
deal.II/deal.II/source/grid/grid_refinement.cc
deal.II/deal.II/source/numerics/matrices.all_dimensions.cc

index 5554f33e2a3b4e253efedfe64b1bcf9290a43282..978fa0baa108ab036c65890f9e4d0beaf985dc01 100644 (file)
@@ -39,8 +39,8 @@ template <int dim> class FEValues;
 #ifdef DEAL_II_USE_PETSC
 namespace PETScWrappers
 {
-  class MatrixBase;
-  class VectorBase;
+  class SparseMatrix;
+  class Vector;
 }
 #endif
 
@@ -779,9 +779,9 @@ class MatrixTools : public MatrixCreator
 #ifdef DEAL_II_USE_PETSC
     static void
     apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                          PETScWrappers::MatrixBase  &matrix,
-                          PETScWrappers::VectorBase  &solution,
-                          PETScWrappers::VectorBase  &right_hand_side,
+                          PETScWrappers::SparseMatrix  &matrix,
+                          PETScWrappers::Vector  &solution,
+                          PETScWrappers::Vector  &right_hand_side,
                           const bool             eliminate_columns = true);
 #endif
 
index 3056bc1fee909279f982975aeedcef27b4897d5e..ea6c0021f3e57ebd6b0643752cfbc2135b1df078 100644 (file)
@@ -50,7 +50,7 @@ namespace
 
 #ifdef DEAL_II_USE_PETSC  
   PetscScalar
-  max_element (const PETScWrappers::VectorBase &criteria)
+  max_element (const PETScWrappers::Vector &criteria)
   {
                                      // this is horribly slow (since we have
                                      // to get the array of values from PETSc
@@ -63,7 +63,7 @@ namespace
 
 
   PetscScalar
-  min_element (const PETScWrappers::VectorBase &criteria)
+  min_element (const PETScWrappers::Vector &criteria)
   {
                                      // this is horribly slow (since we have
                                      // to get the array of values from PETSc
@@ -432,14 +432,14 @@ template
 void
 GridRefinement::
 refine (Triangulation<deal_II_dimension> &,
-        const PETScWrappers::VectorBase &,
+        const PETScWrappers::Vector &,
         const double);
 
 template
 void
 GridRefinement::
 coarsen (Triangulation<deal_II_dimension> &,
-         const PETScWrappers::VectorBase &,
+         const PETScWrappers::Vector &,
          const double);
 
 
@@ -447,7 +447,7 @@ template
 void
 GridRefinement::
 refine_and_coarsen_fixed_number (Triangulation<deal_II_dimension> &,
-                                 const PETScWrappers::VectorBase &,
+                                 const PETScWrappers::Vector &,
                                  const double,
                                  const double);
 
@@ -455,7 +455,7 @@ template
 void
 GridRefinement::
 refine_and_coarsen_fixed_fraction (Triangulation<deal_II_dimension> &,
-                                   const PETScWrappers::VectorBase &,
+                                   const PETScWrappers::Vector &,
                                    const double,
                                    const double);
 
@@ -463,5 +463,5 @@ template
 void
 GridRefinement::
 refine_and_coarsen_optimize (Triangulation<deal_II_dimension> &,
-                             const PETScWrappers::VectorBase &);
+                             const PETScWrappers::Vector &);
 #endif
index 3301c70663de4095385a2263deccad9c03560d71..01f141fadf6b5950e9b85f06023c5dbe69e65915 100644 (file)
@@ -20,8 +20,8 @@
 #include <lac/block_sparse_matrix.h>
 
 #ifdef DEAL_II_USE_PETSC
-#  include <lac/petsc_matrix_base.h>
-#  include <lac/petsc_vector_base.h>
+#  include <lac/petsc_sparse_matrix.h>
+#  include <lac/petsc_vector.h>
 #endif
 
 #include <algorithm>
@@ -519,9 +519,9 @@ MatrixTools::apply_boundary_values (const std::map<unsigned int,double> &boundar
 void
 MatrixTools::
 apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                       PETScWrappers::MatrixBase   &matrix,
-                       PETScWrappers::VectorBase   &solution,
-                       PETScWrappers::VectorBase   &right_hand_side,
+                       PETScWrappers::SparseMatrix   &matrix,
+                       PETScWrappers::Vector   &solution,
+                       PETScWrappers::Vector   &right_hand_side,
                        const bool        preserve_symmetry)
 {
   Assert (matrix.n() == right_hand_side.size(),

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.