]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Duplicate code once, not twice. PETScWrappers::SparseMatrix::MPI::*norm* is just...
authoryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 22 Aug 2012 10:09:55 +0000 (10:09 +0000)
committeryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 22 Aug 2012 10:09:55 +0000 (10:09 +0000)
git-svn-id: https://svn.dealii.org/trunk@26070 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/lac/petsc_sparse_matrix.h
deal.II/source/lac/petsc_sparse_matrix.cc

index aebee7087b0a7e6ed2a372036da01b4ecea4d3ba..57354332781580c949aca7e2763fa18b64352612 100644 (file)
@@ -276,49 +276,6 @@ namespace PETScWrappers
                                         */
       virtual const MPI_Comm & get_mpi_communicator () const;
 
-                                       /**
-                                        * Return the square of the norm
-                                        * of the vector $v$ with respect
-                                        * to the norm induced by this
-                                        * matrix,
-                                        * i.e. $\left(v,Mv\right)$. This
-                                        * is useful, e.g. in the finite
-                                        * element context, where the
-                                        * $L_2$ norm of a function
-                                        * equals the matrix norm with
-                                        * respect to the mass matrix of
-                                        * the vector representing the
-                                        * nodal values of the finite
-                                        * element function.
-                                        *
-                                        * Obviously, the matrix needs to
-                                        * be quadratic for this operation.
-                                        *
-                                        * The implementation of this function
-                                        * is not as efficient as the one in
-                                        * the @p MatrixBase class used in
-                                        * deal.II (i.e. the original one, not
-                                        * the PETSc wrapper class) since PETSc
-                                        * doesn't support this operation and
-                                        * needs a temporary vector.
-                                        */
-      PetscScalar matrix_norm_square (const VectorBase &v) const;
-
-                                       /**
-                                        * Compute the matrix scalar
-                                        * product $\left(u,Mv\right)$.
-                                        *
-                                        * The implementation of this function
-                                        * is not as efficient as the one in
-                                        * the @p MatrixBase class used in
-                                        * deal.II (i.e. the original one, not
-                                        * the PETSc wrapper class) since PETSc
-                                        * doesn't support this operation and
-                                        * needs a temporary vector.
-                                        */
-      PetscScalar matrix_scalar_product (const VectorBase &u,
-                                         const VectorBase &v) const;
-
     private:
 
                                        /**
index c69443649718ae4b7d16ee892eb1f31789513bf0..f6a3fe5242716bb864ec4e79f70a17bd878ad02a 100644 (file)
@@ -352,23 +352,6 @@ namespace PETScWrappers
   template void
   SparseMatrix::do_reinit (const CompressedSimpleSparsityPattern &,
                            const bool);
-
-  PetscScalar
-  SparseMatrix::matrix_norm_square (const VectorBase &v) const
-  {
-    Vector tmp (v.size());
-    vmult (tmp, v);
-    return tmp*v;
-  }
-
-  PetscScalar
-  SparseMatrix::matrix_scalar_product (const VectorBase &u,
-                                      const VectorBase &v) const
-  {
-    Vector tmp (v.size());
-    vmult (tmp, v);
-    return u*tmp;
-  }
 }
 
 

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.