git-svn-id: https://svn.dealii.org/branches/branch_petscscalar_complex@31140
0785d39b-7218-0410-832d-
ea1e28bc413d
--- /dev/null
+? CHANGES
+? build
+M include/deal.II/algorithms/operator.templates.h
+M include/deal.II/lac/block_vector_base.h
+M include/deal.II/lac/constraint_matrix.templates.h
+M include/deal.II/lac/petsc_vector_base.h
+M include/deal.II/numerics/vector_tools.templates.h
+M source/fe/fe_tools_interpolate.cc
+M source/fe/fe_values.cc
+M source/grid/grid_refinement.cc
+M source/numerics/data_out_dof_data.cc
+M source/numerics/matrix_tools.cc
+M source/numerics/point_value_history.cc
SparseMatrix::~SparseMatrix ()
{
+ int ierr;
+
#if DEAL_II_PETSC_VERSION_LT(3,2,0)
- const int ierr = MatDestroy (matrix);
+ ierr = MatDestroy (matrix);
#else
- const int ierr = MatDestroy (&matrix);
+ ierr = MatDestroy (&matrix);
#endif
+ AssertThrow (ierr == 0, ExcPETScError(ierr));
}
SparseMatrix::SparseMatrix (const MPI_Comm &communicator,
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