From c263c947c180f0eb10f81e71d0e69c923c5a6b80 Mon Sep 17 00:00:00 2001 From: heister Date: Fri, 21 Dec 2012 01:36:49 +0000 Subject: [PATCH] revert whitespace changes git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27839 0785d39b-7218-0410-832d-ea1e28bc413d --- .../deal.II/base/conditional_ostream.h | 2 +- deal.II/include/deal.II/base/data_out_base.h | 2 +- deal.II/include/deal.II/base/exceptions.h | 8 ++--- deal.II/include/deal.II/base/geometry_info.h | 4 +-- deal.II/include/deal.II/base/logstream.h | 4 +-- deal.II/include/deal.II/base/parallel.h | 2 +- .../include/deal.II/base/parameter_handler.h | 6 ++-- deal.II/include/deal.II/base/partitioner.h | 2 +- deal.II/include/deal.II/base/qprojector.h | 6 ++-- deal.II/include/deal.II/base/smartpointer.h | 8 ++--- deal.II/include/deal.II/base/utilities.h | 6 ++-- deal.II/include/deal.II/grid/grid_generator.h | 10 +++---- deal.II/include/deal.II/grid/grid_in.h | 6 ++-- .../deal.II/grid/grid_reordering_internal.h | 2 +- deal.II/include/deal.II/grid/grid_tools.h | 4 +-- deal.II/include/deal.II/grid/tria_boundary.h | 2 +- .../include/deal.II/lac/block_matrix_base.h | 12 ++++---- deal.II/include/deal.II/lac/matrix_block.h | 2 +- deal.II/include/deal.II/lac/parallel_vector.h | 10 +++---- .../deal.II/lac/petsc_block_sparse_matrix.h | 6 ++-- .../include/deal.II/lac/petsc_block_vector.h | 2 +- .../lac/petsc_parallel_block_sparse_matrix.h | 6 ++-- deal.II/include/deal.II/lac/sparse_matrix.h | 4 +-- .../include/deal.II/lac/sparsity_pattern.h | 2 +- .../lac/trilinos_block_sparse_matrix.h | 16 +++++----- .../deal.II/lac/trilinos_vector_base.h | 6 ++-- deal.II/include/deal.II/lac/vector.h | 8 ++--- .../deal.II/matrix_free/fe_evaluation.h | 8 ++--- .../deal.II/matrix_free/mapping_info.h | 4 +-- .../deal.II/meshworker/integration_info.h | 12 ++++---- deal.II/include/deal.II/multigrid/mg_coarse.h | 4 +-- .../numerics/derivative_approximation.h | 8 ++--- .../deal.II/numerics/error_estimator.h | 2 +- .../include/deal.II/numerics/matrix_tools.h | 30 +++++++++---------- .../include/deal.II/numerics/vector_tools.h | 2 +- .../deal.II/numerics/vector_tools.templates.h | 4 +-- 36 files changed, 111 insertions(+), 111 deletions(-) diff --git a/deal.II/include/deal.II/base/conditional_ostream.h b/deal.II/include/deal.II/base/conditional_ostream.h index 753ade963e..d786f5d02e 100644 --- a/deal.II/include/deal.II/base/conditional_ostream.h +++ b/deal.II/include/deal.II/base/conditional_ostream.h @@ -148,7 +148,7 @@ private: * Reference to the stream we * want to write to. */ - std::ostream &output_stream; + std::ostream &output_stream; /** * Stores the actual condition diff --git a/deal.II/include/deal.II/base/data_out_base.h b/deal.II/include/deal.II/base/data_out_base.h index a8124528fc..f1ff018f5c 100644 --- a/deal.II/include/deal.II/base/data_out_base.h +++ b/deal.II/include/deal.II/base/data_out_base.h @@ -2442,7 +2442,7 @@ public: * @author Marco Engelhard, 2012 */ void write_pvd_record (std::ostream &out, - const std::vector > ×_and_names) const; + const std::vector > ×_and_names) const; /** * This function is the exact diff --git a/deal.II/include/deal.II/base/exceptions.h b/deal.II/include/deal.II/base/exceptions.h index d74bbb592b..822a0f7fe7 100644 --- a/deal.II/include/deal.II/base/exceptions.h +++ b/deal.II/include/deal.II/base/exceptions.h @@ -114,7 +114,7 @@ protected: /** * Name of the file this exception happen in. */ - const char *file; + const char *file; /** * Line number in this file. @@ -124,17 +124,17 @@ protected: /** * Name of the function, pretty printed. */ - const char *function; + const char *function; /** * The violated condition, as a string. */ - const char *cond; + const char *cond; /** * Name of the exception and call sequence. */ - const char *exc; + const char *exc; /** * A backtrace to the position where the problem happened, if the diff --git a/deal.II/include/deal.II/base/geometry_info.h b/deal.II/include/deal.II/base/geometry_info.h index b2d09128bc..eaca619760 100644 --- a/deal.II/include/deal.II/base/geometry_info.h +++ b/deal.II/include/deal.II/base/geometry_info.h @@ -2736,7 +2736,7 @@ GeometryInfo<3>::cell_to_child_coordinates (const Point<3> &p, template inline Point -GeometryInfo::cell_to_child_coordinates (const Point &/*p*/, +GeometryInfo::cell_to_child_coordinates (const Point & /*p*/, const unsigned int /*child_index*/, const RefinementCase /*refine_case*/) @@ -2880,7 +2880,7 @@ GeometryInfo<2>::child_to_cell_coordinates (const Point<2> &p, template inline Point -GeometryInfo::child_to_cell_coordinates (const Point &/*p*/, +GeometryInfo::child_to_cell_coordinates (const Point & /*p*/, const unsigned int /*child_index*/, const RefinementCase /*refine_case*/) { diff --git a/deal.II/include/deal.II/base/logstream.h b/deal.II/include/deal.II/base/logstream.h index cb50979e38..d4d47ef84b 100644 --- a/deal.II/include/deal.II/base/logstream.h +++ b/deal.II/include/deal.II/base/logstream.h @@ -450,7 +450,7 @@ private: * to std::cerr, but can be set to another * stream through the constructor. */ - std::ostream *std_out; + std::ostream *std_out; /** * Pointer to a stream, where a copy of @@ -460,7 +460,7 @@ private: * You can set and reset this stream * by the attach function. */ - std::ostream *file; + std::ostream *file; /** * Value denoting the number of diff --git a/deal.II/include/deal.II/base/parallel.h b/deal.II/include/deal.II/base/parallel.h index 0afd44ae30..2036053859 100644 --- a/deal.II/include/deal.II/base/parallel.h +++ b/deal.II/include/deal.II/base/parallel.h @@ -347,7 +347,7 @@ namespace parallel */ template void apply_to_subranges (const tbb::blocked_range &range, - const Function &f) + const Function &f) { f (range.begin(), range.end()); } diff --git a/deal.II/include/deal.II/base/parameter_handler.h b/deal.II/include/deal.II/base/parameter_handler.h index f19849ef96..8d706cba21 100644 --- a/deal.II/include/deal.II/base/parameter_handler.h +++ b/deal.II/include/deal.II/base/parameter_handler.h @@ -571,7 +571,7 @@ namespace Patterns * and maximal allowable * lengths of the list. */ - List (const PatternBase &base_pattern, + List (const PatternBase &base_pattern, const unsigned int min_elements = 0, const unsigned int max_elements = max_int_value); @@ -705,8 +705,8 @@ namespace Patterns * and maximal allowable * lengths of the list. */ - Map (const PatternBase &key_pattern, - const PatternBase &value_pattern, + Map (const PatternBase &key_pattern, + const PatternBase &value_pattern, const unsigned int min_elements = 0, const unsigned int max_elements = max_int_value); diff --git a/deal.II/include/deal.II/base/partitioner.h b/deal.II/include/deal.II/base/partitioner.h index fff826924b..9203409bf6 100644 --- a/deal.II/include/deal.II/base/partitioner.h +++ b/deal.II/include/deal.II/base/partitioner.h @@ -470,7 +470,7 @@ namespace Utilities inline - const IndexSet &Partitioner::ghost_indices() const + const IndexSet &Partitioner::ghost_indices() const { return ghost_indices_data; } diff --git a/deal.II/include/deal.II/base/qprojector.h b/deal.II/include/deal.II/base/qprojector.h index c89c41ffe7..e63769f99b 100644 --- a/deal.II/include/deal.II/base/qprojector.h +++ b/deal.II/include/deal.II/base/qprojector.h @@ -123,7 +123,7 @@ public: static void project_to_subface (const SubQuadrature &quadrature, const unsigned int face_no, const unsigned int subface_no, - std::vector > &q_points, + std::vector > &q_points, const RefinementCase &ref_case=RefinementCase::isotropic_refinement); /** @@ -226,7 +226,7 @@ public: */ static Quadrature - project_to_child (const Quadrature &quadrature, + project_to_child (const Quadrature &quadrature, const unsigned int child_no); /** @@ -249,7 +249,7 @@ public: */ static Quadrature - project_to_all_children (const Quadrature &quadrature); + project_to_all_children (const Quadrature &quadrature); /** * Project the onedimensional diff --git a/deal.II/include/deal.II/base/smartpointer.h b/deal.II/include/deal.II/base/smartpointer.h index 1efb98f93d..afb56e0f90 100644 --- a/deal.II/include/deal.II/base/smartpointer.h +++ b/deal.II/include/deal.II/base/smartpointer.h @@ -218,7 +218,7 @@ public: * want to change the pointer * variable which we are given. */ - void swap (T *&tt); + void swap (T *&tt); /** * Return an estimate of the @@ -444,7 +444,7 @@ void SmartPointer::swap (SmartPointer &tt) template inline -void SmartPointer::swap (T *&tt) +void SmartPointer::swap (T *&tt) { if (t != 0) t->unsubscribe (id); @@ -491,7 +491,7 @@ void swap (SmartPointer &t1, SmartPointer &t2) */ template inline -void swap (SmartPointer &t1, T *&t2) +void swap (SmartPointer &t1, T *&t2) { t1.swap (t2); } @@ -507,7 +507,7 @@ void swap (SmartPointer &t1, T *&t2) */ template inline -void swap (T *&t1, SmartPointer &t2) +void swap (T *&t1, SmartPointer &t2) { t2.swap (t1); } diff --git a/deal.II/include/deal.II/base/utilities.h b/deal.II/include/deal.II/base/utilities.h index 063d1dd202..657472427d 100644 --- a/deal.II/include/deal.II/base/utilities.h +++ b/deal.II/include/deal.II/base/utilities.h @@ -287,7 +287,7 @@ namespace Utilities Iterator lower_bound (Iterator first, Iterator last, - const T &val); + const T &val); /** @@ -660,7 +660,7 @@ namespace Utilities * the duplicate_communicator() function. */ Epetra_Map - duplicate_map (const Epetra_BlockMap &map, + duplicate_map (const Epetra_BlockMap &map, const Epetra_Comm &comm); } @@ -705,7 +705,7 @@ namespace Utilities Iterator lower_bound (Iterator first, Iterator last, - const T &val) + const T &val) { return Utilities::lower_bound (first, last, val, std::less()); diff --git a/deal.II/include/deal.II/grid/grid_generator.h b/deal.II/include/deal.II/grid/grid_generator.h index 2cea902ac0..d9a15f9b5f 100644 --- a/deal.II/include/deal.II/grid/grid_generator.h +++ b/deal.II/include/deal.II/grid/grid_generator.h @@ -83,7 +83,7 @@ public: * function. */ template - static void hyper_cube (Triangulation &tria, + static void hyper_cube (Triangulation &tria, const double left = 0., const double right= 1.); @@ -114,7 +114,7 @@ public: * function. */ template - static void subdivided_hyper_cube (Triangulation &tria, + static void subdivided_hyper_cube (Triangulation &tria, const unsigned int repetitions, const double left = 0., const double right= 1.); @@ -304,7 +304,7 @@ public: */ template static void - parallelogram(Triangulation &tria, + parallelogram(Triangulation &tria, const Tensor<2,dim> &corners, const bool colorize=false); @@ -787,7 +787,7 @@ public: * torus. */ - static void torus (Triangulation<2,3> &tria, + static void torus (Triangulation<2,3> &tria, const double R, const double r); @@ -841,7 +841,7 @@ public: * @param R The radius of the circle, which forms the middle line of the torus containing the loop of cells. Must be greater than @p r. * @param r The radius of the cylinder bend together as loop. */ - static void moebius (Triangulation<3,3> &tria, + static void moebius (Triangulation<3,3> &tria, const unsigned int n_cells, const unsigned int n_rotations, const double R, diff --git a/deal.II/include/deal.II/grid/grid_in.h b/deal.II/include/deal.II/grid/grid_in.h index fbd5110423..067f89caa4 100644 --- a/deal.II/include/deal.II/grid/grid_in.h +++ b/deal.II/include/deal.II/grid/grid_in.h @@ -581,9 +581,9 @@ private: */ static void parse_tecplot_header(std::string &header, std::vector &tecplot2deal, - unsigned int &n_vars, - unsigned int &n_vertices, - unsigned int &n_cells, + unsigned int &n_vars, + unsigned int &n_vertices, + unsigned int &n_cells, std::vector &IJK, bool &structured, bool &blocked); diff --git a/deal.II/include/deal.II/grid/grid_reordering_internal.h b/deal.II/include/deal.II/grid/grid_reordering_internal.h index 89c89b7da4..3d15b6f19c 100644 --- a/deal.II/include/deal.II/grid/grid_reordering_internal.h +++ b/deal.II/include/deal.II/grid/grid_reordering_internal.h @@ -125,7 +125,7 @@ namespace internal const unsigned int s1, const unsigned int s2, const unsigned int s3, - const CellData<2> &cd); + const CellData<2> &cd); /** * Stores the vertex numbers diff --git a/deal.II/include/deal.II/grid/grid_tools.h b/deal.II/include/deal.II/grid/grid_tools.h index 56fbba891c..6abe799679 100644 --- a/deal.II/include/deal.II/grid/grid_tools.h +++ b/deal.II/include/deal.II/grid/grid_tools.h @@ -332,7 +332,7 @@ namespace GridTools */ template class Container, int spacedim> typename Container::active_cell_iterator - find_active_cell_around_point (const Container &container, + find_active_cell_around_point (const Container &container, const Point &p); /** @@ -588,7 +588,7 @@ namespace GridTools */ template void - get_subdomain_association (const Triangulation &triangulation, + get_subdomain_association (const Triangulation &triangulation, std::vector &subdomain); /** diff --git a/deal.II/include/deal.II/grid/tria_boundary.h b/deal.II/include/deal.II/grid/tria_boundary.h index ef462423f8..f093c5eb76 100644 --- a/deal.II/include/deal.II/grid/tria_boundary.h +++ b/deal.II/include/deal.II/grid/tria_boundary.h @@ -691,7 +691,7 @@ template <> Point<3> StraightBoundary<1,3>:: project_to_surface (const Triangulation<1, 3>::quad_iterator &quad, - const Point<3> &y) const; + const Point<3> &y) const; #endif // DOXYGEN diff --git a/deal.II/include/deal.II/lac/block_matrix_base.h b/deal.II/include/deal.II/lac/block_matrix_base.h index 8cd475e641..d7de0a7eb2 100644 --- a/deal.II/include/deal.II/lac/block_matrix_base.h +++ b/deal.II/include/deal.II/lac/block_matrix_base.h @@ -1135,7 +1135,7 @@ protected: */ template - void Tvmult_block_nonblock (BlockVectorType &dst, + void Tvmult_block_nonblock (BlockVectorType &dst, const VectorType &src) const; /** @@ -1289,7 +1289,7 @@ namespace BlockMatrixIterators template inline Accessor::Accessor ( - const BlockMatrix *matrix, + const BlockMatrix *matrix, const unsigned int row, const unsigned int col) : @@ -1498,7 +1498,7 @@ namespace BlockMatrixIterators template inline Accessor::Accessor ( - BlockMatrix *matrix, + BlockMatrix *matrix, const unsigned int row, const unsigned int col) : @@ -2118,7 +2118,7 @@ inline void BlockMatrixBase::add (const unsigned int row, const unsigned int n_cols, - const unsigned int *col_indices, + const unsigned int *col_indices, const number *values, const bool elide_zero_values, const bool col_indices_are_sorted) @@ -2427,7 +2427,7 @@ template void BlockMatrixBase:: -vmult_block_nonblock (BlockVectorType &dst, +vmult_block_nonblock (BlockVectorType &dst, const VectorType &src) const { Assert (dst.n_blocks() == n_block_rows(), @@ -2512,7 +2512,7 @@ template void BlockMatrixBase:: -Tvmult_block_nonblock (BlockVectorType &dst, +Tvmult_block_nonblock (BlockVectorType &dst, const VectorType &src) const { Assert (dst.n_blocks() == n_block_cols(), diff --git a/deal.II/include/deal.II/lac/matrix_block.h b/deal.II/include/deal.II/lac/matrix_block.h index e2eb43ef72..eb44751866 100644 --- a/deal.II/include/deal.II/lac/matrix_block.h +++ b/deal.II/include/deal.II/lac/matrix_block.h @@ -793,7 +793,7 @@ inline void MatrixBlock::add (const unsigned int b_row, const unsigned int n_cols, - const unsigned int *col_indices, + const unsigned int *col_indices, const number *values, const bool, const bool) diff --git a/deal.II/include/deal.II/lac/parallel_vector.h b/deal.II/include/deal.II/lac/parallel_vector.h index e1c53ceb32..d16f47870d 100644 --- a/deal.II/include/deal.II/lac/parallel_vector.h +++ b/deal.II/include/deal.II/lac/parallel_vector.h @@ -254,7 +254,7 @@ namespace parallel * in_vector, and copies all the data. */ Vector & - operator = (const Vector &in_vector); + operator = (const Vector &in_vector); /** * Assigns the vector to the parallel @@ -654,7 +654,7 @@ namespace parallel */ template void add (const std::vector &indices, - const std::vector &values); + const std::vector &values); /** * This is a second collective @@ -679,7 +679,7 @@ namespace parallel template void add (const unsigned int n_elements, const unsigned int *indices, - const OtherNumber *values); + const OtherNumber *values); /** * Addition of @p s to all @@ -1537,7 +1537,7 @@ namespace parallel inline void Vector::add (const std::vector &indices, - const std::vector &values) + const std::vector &values) { AssertDimension (indices.size(), values.size()); add (indices.size(), &indices[0], &values[0]); @@ -1564,7 +1564,7 @@ namespace parallel void Vector::add (const unsigned int n_indices, const unsigned int *indices, - const OtherNumber *values) + const OtherNumber *values) { for (unsigned int i=0; i & - operator= (const IdentityMatrix &id); + operator= (const IdentityMatrix &id); /** * This operator assigns a scalar to a matrix. Since this does usually not diff --git a/deal.II/include/deal.II/lac/sparsity_pattern.h b/deal.II/include/deal.II/lac/sparsity_pattern.h index 5c13c278e0..fe87da3f19 100644 --- a/deal.II/include/deal.II/lac/sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/sparsity_pattern.h @@ -404,7 +404,7 @@ public: * matrix structure. It must be compressed. The matrix structure is not * compressed after this function finishes. */ - SparsityPattern (const SparsityPattern &original, + SparsityPattern (const SparsityPattern &original, const unsigned int max_per_row, const unsigned int extra_off_diagonals); diff --git a/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h b/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h index b49b57eb6c..0680b3c883 100644 --- a/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -318,7 +318,7 @@ namespace TrilinosWrappers * applicable if the matrix has * only one block column. */ - void vmult (MPI::BlockVector &dst, + void vmult (MPI::BlockVector &dst, const MPI::Vector &src) const; /** @@ -331,7 +331,7 @@ namespace TrilinosWrappers * (works only when run on one * processor). */ - void vmult (BlockVector &dst, + void vmult (BlockVector &dst, const Vector &src) const; /** @@ -399,7 +399,7 @@ namespace TrilinosWrappers * applicable if the matrix has * only one block row. */ - void Tvmult (MPI::BlockVector &dst, + void Tvmult (MPI::BlockVector &dst, const MPI::Vector &src) const; /** @@ -412,7 +412,7 @@ namespace TrilinosWrappers * vectors (works only when run * on one processor). */ - void Tvmult (BlockVector &dst, + void Tvmult (BlockVector &dst, const Vector &src) const; /** @@ -688,7 +688,7 @@ namespace TrilinosWrappers inline void - BlockSparseMatrix::vmult (MPI::BlockVector &dst, + BlockSparseMatrix::vmult (MPI::BlockVector &dst, const MPI::Vector &src) const { BaseClass::vmult_block_nonblock (dst, src); @@ -698,7 +698,7 @@ namespace TrilinosWrappers inline void - BlockSparseMatrix::vmult (BlockVector &dst, + BlockSparseMatrix::vmult (BlockVector &dst, const Vector &src) const { BaseClass::vmult_block_nonblock (dst, src); @@ -758,7 +758,7 @@ namespace TrilinosWrappers inline void - BlockSparseMatrix::Tvmult (MPI::BlockVector &dst, + BlockSparseMatrix::Tvmult (MPI::BlockVector &dst, const MPI::Vector &src) const { BaseClass::Tvmult_block_nonblock (dst, src); @@ -768,7 +768,7 @@ namespace TrilinosWrappers inline void - BlockSparseMatrix::Tvmult (BlockVector &dst, + BlockSparseMatrix::Tvmult (BlockVector &dst, const Vector &src) const { BaseClass::Tvmult_block_nonblock (dst, src); diff --git a/deal.II/include/deal.II/lac/trilinos_vector_base.h b/deal.II/include/deal.II/lac/trilinos_vector_base.h index 76bee84634..6e386f86bf 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector_base.h +++ b/deal.II/include/deal.II/lac/trilinos_vector_base.h @@ -644,7 +644,7 @@ namespace TrilinosWrappers * values in the second. */ void set (const std::vector &indices, - const std::vector &values); + const std::vector &values); /** * This is a second collective @@ -1312,7 +1312,7 @@ namespace TrilinosWrappers inline void VectorBase::set (const std::vector &indices, - const std::vector &values) + const std::vector &values) { // if we have ghost values, do not allow // writing to this vector at all. @@ -1381,7 +1381,7 @@ namespace TrilinosWrappers inline void VectorBase::add (const std::vector &indices, - const std::vector &values) + const std::vector &values) { // if we have ghost values, do not allow // writing to this vector at all. diff --git a/deal.II/include/deal.II/lac/vector.h b/deal.II/include/deal.II/lac/vector.h index f4a65a839a..fccc27c794 100644 --- a/deal.II/include/deal.II/lac/vector.h +++ b/deal.II/include/deal.II/lac/vector.h @@ -700,7 +700,7 @@ public: */ template void add (const std::vector &indices, - const std::vector &values); + const std::vector &values); /** * This is a second collective @@ -725,7 +725,7 @@ public: template void add (const unsigned int n_elements, const unsigned int *indices, - const OtherNumber *values); + const OtherNumber *values); /** * Addition of @p s to all @@ -1297,7 +1297,7 @@ template inline void Vector::add (const std::vector &indices, - const std::vector &values) + const std::vector &values) { Assert (indices.size() == values.size(), ExcDimensionMismatch(indices.size(), values.size())); @@ -1326,7 +1326,7 @@ inline void Vector::add (const unsigned int n_indices, const unsigned int *indices, - const OtherNumber *values) + const OtherNumber *values) { for (unsigned int i=0; i inline void FEEvaluationBase -::distribute_local_to_global (std::vector &dst, +::distribute_local_to_global (std::vector &dst, const unsigned int first_index) const { AssertIndexRange (first_index, dst.size()); @@ -2307,7 +2307,7 @@ template inline void FEEvaluationBase -::distribute_local_to_global (std::vector &dst, +::distribute_local_to_global (std::vector &dst, const unsigned int first_index) const { AssertIndexRange (first_index, dst.size()); @@ -2358,7 +2358,7 @@ template inline void FEEvaluationBase -::set_dof_values (std::vector &dst, +::set_dof_values (std::vector &dst, const unsigned int first_index) const { AssertIndexRange (first_index, dst.size()); @@ -2386,7 +2386,7 @@ template inline void FEEvaluationBase -::set_dof_values (std::vector &dst, +::set_dof_values (std::vector &dst, const unsigned int first_index) const { AssertIndexRange (first_index, dst.size()); diff --git a/deal.II/include/deal.II/matrix_free/mapping_info.h b/deal.II/include/deal.II/matrix_free/mapping_info.h index bfd47e83c0..6a46b630ff 100644 --- a/deal.II/include/deal.II/matrix_free/mapping_info.h +++ b/deal.II/include/deal.II/matrix_free/mapping_info.h @@ -77,7 +77,7 @@ namespace internal const std::vector > &cells, const std::vector &active_fe_index, const Mapping &mapping, - const std::vector > &quad, + const std::vector > &quad, const UpdateFlags update_flags); /** @@ -88,7 +88,7 @@ namespace internal */ UpdateFlags compute_update_flags (const UpdateFlags update_flags, - const std::vector > &quad) const; + const std::vector > &quad) const; /** * Returns the type of a given cell as diff --git a/deal.II/include/deal.II/meshworker/integration_info.h b/deal.II/include/deal.II/meshworker/integration_info.h index a57459f2db..e81efbf21f 100644 --- a/deal.II/include/deal.II/meshworker/integration_info.h +++ b/deal.II/include/deal.II/meshworker/integration_info.h @@ -740,8 +740,8 @@ namespace MeshWorker if (pc != 0) fevalv[i] = std_cxx1x::shared_ptr > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (pc->get_mapping(), pc->get_fe(), + pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) fevalv[i] = std_cxx1x::shared_ptr > ( new FEFaceValues (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags())); @@ -778,8 +778,8 @@ namespace MeshWorker if (pc != 0) fevalv[i] = std_cxx1x::shared_ptr > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (pc->get_mapping(), pc->get_fe(), + pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) { Assert (false, ExcImpossibleInDim(1)); @@ -820,8 +820,8 @@ namespace MeshWorker if (pc != 0) fevalv[i] = std_cxx1x::shared_ptr > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (pc->get_mapping(), pc->get_fe(), + pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) { Assert (false, ExcImpossibleInDim(1)); diff --git a/deal.II/include/deal.II/multigrid/mg_coarse.h b/deal.II/include/deal.II/multigrid/mg_coarse.h index fc31e5e29e..8cfc4eb7d2 100644 --- a/deal.II/include/deal.II/multigrid/mg_coarse.h +++ b/deal.II/include/deal.II/multigrid/mg_coarse.h @@ -208,7 +208,7 @@ template template MGCoarseGridLACIteration ::MGCoarseGridLACIteration(SOLVER &s, - const MATRIX &m, + const MATRIX &m, const PRECOND &p) : solver(&s, typeid(*this).name()) @@ -231,7 +231,7 @@ template void MGCoarseGridLACIteration ::initialize(SOLVER &s, - const MATRIX &m, + const MATRIX &m, const PRECOND &p) { solver = &s; diff --git a/deal.II/include/deal.II/numerics/derivative_approximation.h b/deal.II/include/deal.II/numerics/derivative_approximation.h index 0aaa4cc2c5..2958010bd1 100644 --- a/deal.II/include/deal.II/numerics/derivative_approximation.h +++ b/deal.II/include/deal.II/numerics/derivative_approximation.h @@ -380,7 +380,7 @@ private: */ template static ProjectedDerivative - get_projected_derivative (const FEValues &fe_values, + get_projected_derivative (const FEValues &fe_values, const InputVector &solution, const unsigned int component); @@ -461,7 +461,7 @@ private: */ template static ProjectedDerivative - get_projected_derivative (const FEValues &fe_values, + get_projected_derivative (const FEValues &fe_values, const InputVector &solution, const unsigned int component); @@ -539,7 +539,7 @@ private: */ template static ProjectedDerivative - get_projected_derivative (const FEValues &fe_values, + get_projected_derivative (const FEValues &fe_values, const InputVector &solution, const unsigned int component); @@ -690,7 +690,7 @@ private: const DH &dof, const InputVector &solution, const unsigned int component, - const typename DH::active_cell_iterator &cell, + const typename DH::active_cell_iterator &cell, typename DerivativeDescription::Derivative &derivative); }; diff --git a/deal.II/include/deal.II/numerics/error_estimator.h b/deal.II/include/deal.II/numerics/error_estimator.h index 5bdce1a2d1..a17ce5ae70 100644 --- a/deal.II/include/deal.II/numerics/error_estimator.h +++ b/deal.II/include/deal.II/numerics/error_estimator.h @@ -603,7 +603,7 @@ public: * general case. */ template - static void estimate (const Mapping<1,spacedim> &mapping, + static void estimate (const Mapping<1,spacedim> &mapping, const DH &dof, const Quadrature<0> &quadrature, const typename FunctionMap::type &neumann_bc, diff --git a/deal.II/include/deal.II/numerics/matrix_tools.h b/deal.II/include/deal.II/numerics/matrix_tools.h index 980235f1e8..a34eec00b1 100644 --- a/deal.II/include/deal.II/numerics/matrix_tools.h +++ b/deal.II/include/deal.II/numerics/matrix_tools.h @@ -806,7 +806,7 @@ namespace MatrixTools template void apply_boundary_values (const std::map &boundary_values, - SparseMatrix &matrix, + SparseMatrix &matrix, Vector &solution, Vector &right_hand_side, const bool eliminate_columns = true); @@ -868,9 +868,9 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - PETScWrappers::SparseMatrix &matrix, - PETScWrappers::Vector &solution, - PETScWrappers::Vector &right_hand_side, + PETScWrappers::SparseMatrix &matrix, + PETScWrappers::Vector &solution, + PETScWrappers::Vector &right_hand_side, const bool eliminate_columns = true); /** @@ -879,9 +879,9 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - PETScWrappers::MPI::SparseMatrix &matrix, - PETScWrappers::MPI::Vector &solution, - PETScWrappers::MPI::Vector &right_hand_side, + PETScWrappers::MPI::SparseMatrix &matrix, + PETScWrappers::MPI::Vector &solution, + PETScWrappers::MPI::Vector &right_hand_side, const bool eliminate_columns = true); /** @@ -911,17 +911,17 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - PETScWrappers::MPI::SparseMatrix &matrix, + PETScWrappers::MPI::SparseMatrix &matrix, PETScWrappers::Vector &solution, - PETScWrappers::MPI::Vector &right_hand_side, + PETScWrappers::MPI::Vector &right_hand_side, const bool eliminate_columns = true); /** * Same as above but for BlockSparseMatrix. */ void - apply_boundary_values (const std::map &boundary_values, - PETScWrappers::MPI::BlockSparseMatrix &matrix, + apply_boundary_values (const std::map &boundary_values, + PETScWrappers::MPI::BlockSparseMatrix &matrix, PETScWrappers::MPI::BlockVector &solution, PETScWrappers::MPI::BlockVector &right_hand_side, const bool eliminate_columns = true); @@ -969,7 +969,7 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - TrilinosWrappers::SparseMatrix &matrix, + TrilinosWrappers::SparseMatrix &matrix, TrilinosWrappers::Vector &solution, TrilinosWrappers::Vector &right_hand_side, const bool eliminate_columns = true); @@ -981,7 +981,7 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - TrilinosWrappers::BlockSparseMatrix &matrix, + TrilinosWrappers::BlockSparseMatrix &matrix, TrilinosWrappers::BlockVector &solution, TrilinosWrappers::BlockVector &right_hand_side, const bool eliminate_columns = true); @@ -1024,7 +1024,7 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - TrilinosWrappers::SparseMatrix &matrix, + TrilinosWrappers::SparseMatrix &matrix, TrilinosWrappers::MPI::Vector &solution, TrilinosWrappers::MPI::Vector &right_hand_side, const bool eliminate_columns = true); @@ -1036,7 +1036,7 @@ namespace MatrixTools */ void apply_boundary_values (const std::map &boundary_values, - TrilinosWrappers::BlockSparseMatrix &matrix, + TrilinosWrappers::BlockSparseMatrix &matrix, TrilinosWrappers::MPI::BlockVector &solution, TrilinosWrappers::MPI::BlockVector &right_hand_side, const bool eliminate_columns = true); diff --git a/deal.II/include/deal.II/numerics/vector_tools.h b/deal.II/include/deal.II/numerics/vector_tools.h index ba3ef871d6..1f2160480a 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.h +++ b/deal.II/include/deal.II/numerics/vector_tools.h @@ -574,7 +574,7 @@ namespace VectorTools interpolate_to_different_mesh (const DH &dof1, const VECTOR &u1, const DH &dof2, - const ConstraintMatrix &constraints, + const ConstraintMatrix &constraints, VECTOR &u2); diff --git a/deal.II/include/deal.II/numerics/vector_tools.templates.h b/deal.II/include/deal.II/numerics/vector_tools.templates.h index cb91da685c..a96dfb3a24 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.templates.h +++ b/deal.II/include/deal.II/numerics/vector_tools.templates.h @@ -479,7 +479,7 @@ namespace VectorTools interpolate_to_different_mesh (const DH &dof1, const Vector &u1, const DH &dof2, - const ConstraintMatrix &constraints, + const ConstraintMatrix &constraints, Vector &u2) { Assert(GridTools::have_same_coarse_mesh(dof1, dof2), @@ -2109,7 +2109,7 @@ namespace VectorTools const DoFHandler &dof, const typename FunctionMap::type &boundary_functions, const Quadrature &q, - std::map &boundary_values, + std::map &boundary_values, std::vector component_mapping) { //TODO:[?] In project_boundary_values, no condensation of sparsity -- 2.39.5