From: heister Date: Fri, 21 Dec 2012 01:38:13 +0000 (+0000) Subject: revert whitespace changes X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=c0687ae51bfc11d7a31cd65de0b03c995beace00;p=dealii-svn.git revert whitespace changes git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27840 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/fe/fe_nothing.h b/deal.II/include/deal.II/fe/fe_nothing.h index 9ed2d3ca9f..e4cfcea543 100644 --- a/deal.II/include/deal.II/fe/fe_nothing.h +++ b/deal.II/include/deal.II/fe/fe_nothing.h @@ -339,7 +339,7 @@ public: void get_subface_interpolation_matrix (const FiniteElement &source_fe, const unsigned int index, - FullMatrix &interpolation_matrix) const; + FullMatrix &interpolation_matrix) const; }; diff --git a/deal.II/include/deal.II/fe/fe_poly_tensor.h b/deal.II/include/deal.II/fe/fe_poly_tensor.h index a1f5498330..5650e3365c 100644 --- a/deal.II/include/deal.II/fe/fe_poly_tensor.h +++ b/deal.II/include/deal.II/fe/fe_poly_tensor.h @@ -206,8 +206,8 @@ protected: fill_fe_values (const Mapping &mapping, const typename Triangulation::cell_iterator &cell, const Quadrature &quadrature, - typename Mapping::InternalDataBase &mapping_internal, - typename Mapping::InternalDataBase &fe_internal, + typename Mapping::InternalDataBase &mapping_internal, + typename Mapping::InternalDataBase &fe_internal, FEValuesData &data, CellSimilarity::Similarity &cell_similarity) const; diff --git a/deal.II/include/deal.II/fe/fe_system.h b/deal.II/include/deal.II/fe/fe_system.h index c6c8578985..d80aa71848 100644 --- a/deal.II/include/deal.II/fe/fe_system.h +++ b/deal.II/include/deal.II/fe/fe_system.h @@ -806,8 +806,8 @@ private: * copies around will then delete the pointer to the base elements. */ std::vector >, - unsigned int> > - base_elements; + unsigned int> > + base_elements; /** diff --git a/deal.II/include/deal.II/fe/fe_tools.h b/deal.II/include/deal.II/fe/fe_tools.h index 9c3e3a7af1..91566ae1b1 100644 --- a/deal.II/include/deal.II/fe/fe_tools.h +++ b/deal.II/include/deal.II/fe/fe_tools.h @@ -205,7 +205,7 @@ namespace FETools */ template void compute_block_renumbering ( - const FiniteElement &fe, + const FiniteElement &fe, std::vector &renumbering, std::vector &block_data, bool return_start_indices = true); @@ -873,9 +873,9 @@ namespace FETools template class DH1, template class DH2, class InVector, class OutVector> - void interpolate (const DH1 &dof1, + void interpolate (const DH1 &dof1, const InVector &u1, - const DH2 &dof2, + const DH2 &dof2, const ConstraintMatrix &constraints, OutVector &u2); @@ -953,10 +953,10 @@ namespace FETools * mapping. */ template - void back_interpolate (const DoFHandler &dof1, + void back_interpolate (const DoFHandler &dof1, const ConstraintMatrix &constraints1, const InVector &u1, - const DoFHandler &dof2, + const DoFHandler &dof2, const ConstraintMatrix &constraints2, OutVector &u1_interpolated); @@ -1000,10 +1000,10 @@ namespace FETools * are involved. */ template - void interpolation_difference(const DoFHandler &dof1, + void interpolation_difference(const DoFHandler &dof1, const ConstraintMatrix &constraints1, const InVector &z1, - const DoFHandler &dof2, + const DoFHandler &dof2, const ConstraintMatrix &constraints2, OutVector &z1_difference); @@ -1091,9 +1091,9 @@ namespace FETools * function. */ template - void extrapolate (const DoFHandler &dof1, + void extrapolate (const DoFHandler &dof1, const InVector &z1, - const DoFHandler &dof2, + const DoFHandler &dof2, const ConstraintMatrix &constraints, OutVector &z2); //@} diff --git a/deal.II/include/deal.II/fe/mapping_q1_eulerian.h b/deal.II/include/deal.II/fe/mapping_q1_eulerian.h index f07ab09d42..661abf6d2b 100644 --- a/deal.II/include/deal.II/fe/mapping_q1_eulerian.h +++ b/deal.II/include/deal.II/fe/mapping_q1_eulerian.h @@ -109,7 +109,7 @@ public: * can be initialized by * DoFAccessor::set_dof_values(). */ - MappingQ1Eulerian (const VECTOR &euler_transform_vectors, + MappingQ1Eulerian (const VECTOR &euler_transform_vectors, const DoFHandler &shiftmap_dof_handler); /** diff --git a/deal.II/include/deal.II/fe/mapping_q_eulerian.h b/deal.II/include/deal.II/fe/mapping_q_eulerian.h index 54177ab37b..df7b094683 100644 --- a/deal.II/include/deal.II/fe/mapping_q_eulerian.h +++ b/deal.II/include/deal.II/fe/mapping_q_eulerian.h @@ -113,8 +113,8 @@ public: */ MappingQEulerian (const unsigned int degree, - const VECTOR &euler_vector, - const DoFHandler &euler_dof_handler); + const VECTOR &euler_vector, + const DoFHandler &euler_dof_handler); /** * Return a pointer to a copy of the diff --git a/deal.II/include/deal.II/lac/block_sparse_matrix.h b/deal.II/include/deal.II/lac/block_sparse_matrix.h index 5bc235ae13..32abdf9674 100644 --- a/deal.II/include/deal.II/lac/block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/block_sparse_matrix.h @@ -318,7 +318,7 @@ public: */ template - void Tvmult (BlockVector &dst, + void Tvmult (BlockVector &dst, const Vector &src) const; /** diff --git a/deal.II/include/deal.II/lac/chunk_sparse_matrix.h b/deal.II/include/deal.II/lac/chunk_sparse_matrix.h index 07e4d03fac..59cdb14d5b 100644 --- a/deal.II/include/deal.II/lac/chunk_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/chunk_sparse_matrix.h @@ -172,7 +172,7 @@ public: * diagonal. */ ChunkSparseMatrix (const ChunkSparsityPattern &sparsity, - const IdentityMatrix &id); + const IdentityMatrix &id); /** * Destructor. Free all memory, but do not @@ -215,7 +215,7 @@ public: * diagonal. */ ChunkSparseMatrix & - operator= (const IdentityMatrix &id); + operator= (const IdentityMatrix &id); /** * This operator assigns a scalar to diff --git a/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h b/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h index 6c993b0e19..f176c7827e 100644 --- a/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h +++ b/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h @@ -229,7 +229,7 @@ ChunkSparseMatrix::ChunkSparseMatrix (const ChunkSparsityPattern &c) template ChunkSparseMatrix::ChunkSparseMatrix (const ChunkSparsityPattern &c, - const IdentityMatrix &id) + const IdentityMatrix &id) : cols(0, "ChunkSparseMatrix"), val(0), @@ -282,7 +282,7 @@ ChunkSparseMatrix::operator = (const double d) template ChunkSparseMatrix & -ChunkSparseMatrix::operator= (const IdentityMatrix &id) +ChunkSparseMatrix::operator= (const IdentityMatrix &id) { Assert (cols->n_rows() == id.m(), ExcDimensionMismatch (cols->n_rows(), id.m())); diff --git a/deal.II/include/deal.II/lac/constraint_matrix.h b/deal.II/include/deal.II/lac/constraint_matrix.h index 87a4c3c42d..103433b068 100644 --- a/deal.II/include/deal.II/lac/constraint_matrix.h +++ b/deal.II/include/deal.II/lac/constraint_matrix.h @@ -1363,7 +1363,7 @@ public: template void - get_dof_values (const VectorType &global_vector, + get_dof_values (const VectorType &global_vector, ForwardIteratorInd local_indices_begin, ForwardIteratorVec local_vector_begin, ForwardIteratorVec local_vector_end) const; @@ -1755,7 +1755,7 @@ private: */ void make_sorted_row_list (const std::vector &local_dof_indices, - internals::GlobalRowsFromLocal &global_rows) const; + internals::GlobalRowsFromLocal &global_rows) const; /** * Internal helper function for @@ -2069,7 +2069,7 @@ ConstraintMatrix::distribute_local_to_global ( template inline -void ConstraintMatrix::get_dof_values (const VectorType &global_vector, +void ConstraintMatrix::get_dof_values (const VectorType &global_vector, ForwardIteratorInd local_indices_begin, ForwardIteratorVec local_vector_begin, ForwardIteratorVec local_vector_end) const diff --git a/deal.II/include/deal.II/lac/constraint_matrix.templates.h b/deal.II/include/deal.II/lac/constraint_matrix.templates.h index 63cc9af858..8d7f1b552a 100644 --- a/deal.II/include/deal.II/lac/constraint_matrix.templates.h +++ b/deal.II/include/deal.II/lac/constraint_matrix.templates.h @@ -1649,8 +1649,8 @@ namespace internals const unsigned int column_start, const unsigned int column_end, const FullMatrix &local_matrix, - unsigned int *&col_ptr, - number *&val_ptr) + unsigned int *&col_ptr, + number *&val_ptr) { if (column_end == column_start) return; @@ -2103,7 +2103,7 @@ add_this_index: void ConstraintMatrix:: make_sorted_row_list (const std::vector &local_dof_indices, - internals::GlobalRowsFromLocal &global_rows) const + internals::GlobalRowsFromLocal &global_rows) const { const unsigned int n_local_dofs = local_dof_indices.size(); AssertDimension (n_local_dofs, global_rows.size()); diff --git a/deal.II/include/deal.II/lac/petsc_matrix_base.h b/deal.II/include/deal.II/lac/petsc_matrix_base.h index 634ac7baf0..a4bfe4d4c5 100644 --- a/deal.II/include/deal.II/lac/petsc_matrix_base.h +++ b/deal.II/include/deal.II/lac/petsc_matrix_base.h @@ -433,7 +433,7 @@ namespace PETScWrappers */ void set (const unsigned int row, const std::vector &col_indices, - const std::vector &values, + const std::vector &values, const bool elide_zero_values = false); /** @@ -465,7 +465,7 @@ namespace PETScWrappers void set (const unsigned int row, const unsigned int n_cols, const unsigned int *col_indices, - const PetscScalar *values, + const PetscScalar *values, const bool elide_zero_values = false); /** @@ -569,7 +569,7 @@ namespace PETScWrappers */ void add (const unsigned int row, const std::vector &col_indices, - const std::vector &values, + const std::vector &values, const bool elide_zero_values = true); /** @@ -602,7 +602,7 @@ namespace PETScWrappers void add (const unsigned int row, const unsigned int n_cols, const unsigned int *col_indices, - const PetscScalar *values, + const PetscScalar *values, const bool elide_zero_values = true, const bool col_indices_are_sorted = false); @@ -1511,7 +1511,7 @@ namespace PETScWrappers void MatrixBase::set (const unsigned int row, const std::vector &col_indices, - const std::vector &values, + const std::vector &values, const bool elide_zero_values) { Assert (col_indices.size() == values.size(), @@ -1528,7 +1528,7 @@ namespace PETScWrappers MatrixBase::set (const unsigned int row, const unsigned int n_cols, const unsigned int *col_indices, - const PetscScalar *values, + const PetscScalar *values, const bool elide_zero_values) { prepare_action(LastAction::insert); @@ -1660,7 +1660,7 @@ namespace PETScWrappers void MatrixBase::add (const unsigned int row, const std::vector &col_indices, - const std::vector &values, + const std::vector &values, const bool elide_zero_values) { Assert (col_indices.size() == values.size(), @@ -1677,7 +1677,7 @@ namespace PETScWrappers MatrixBase::add (const unsigned int row, const unsigned int n_cols, const unsigned int *col_indices, - const PetscScalar *values, + const PetscScalar *values, const bool elide_zero_values, const bool /*col_indices_are_sorted*/) { diff --git a/deal.II/include/deal.II/lac/petsc_matrix_free.h b/deal.II/include/deal.II/lac/petsc_matrix_free.h index 2eec3536b7..8c99333fa1 100644 --- a/deal.II/include/deal.II/lac/petsc_matrix_free.h +++ b/deal.II/include/deal.II/lac/petsc_matrix_free.h @@ -310,7 +310,7 @@ namespace PETScWrappers * in derived classes. */ virtual - void vmult (Vec &dst, const Vec &src) const; + void vmult (Vec &dst, const Vec &src) const; private: diff --git a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h index 050e5ea43c..e17ce5b484 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h @@ -108,7 +108,7 @@ namespace PETScWrappers * to those of the given argument and * copy the elements. */ - BlockVector (const BlockVector &V); + BlockVector (const BlockVector &V); /** * Constructor. Set the number of diff --git a/deal.II/include/deal.II/lac/petsc_solver.h b/deal.II/include/deal.II/lac/petsc_solver.h index f2806970f3..ae38d634f0 100644 --- a/deal.II/include/deal.II/lac/petsc_solver.h +++ b/deal.II/include/deal.II/lac/petsc_solver.h @@ -111,7 +111,7 @@ namespace PETScWrappers * see the documentation of the * SolverBase class. */ - SolverBase (SolverControl &cn, + SolverBase (SolverControl &cn, const MPI_Comm &mpi_communicator); /** diff --git a/deal.II/include/deal.II/lac/petsc_vector_base.h b/deal.II/include/deal.II/lac/petsc_vector_base.h index 25c36dc628..eb265a8648 100644 --- a/deal.II/include/deal.II/lac/petsc_vector_base.h +++ b/deal.II/include/deal.II/lac/petsc_vector_base.h @@ -83,7 +83,7 @@ namespace PETScWrappers * as to only allow the actual vector * class to create it. */ - VectorReference (const VectorBase &vector, + VectorReference (const VectorBase &vector, const unsigned int index); public: @@ -438,7 +438,7 @@ namespace PETScWrappers * second. */ void set (const std::vector &indices, - const std::vector &values); + const std::vector &values); /** * A collective add operation: This @@ -447,7 +447,7 @@ namespace PETScWrappers * components specified by @p indices. */ void add (const std::vector &indices, - const std::vector &values); + const std::vector &values); /** * This is a second collective @@ -470,7 +470,7 @@ namespace PETScWrappers */ void add (const unsigned int n_elements, const unsigned int *indices, - const PetscScalar *values); + const PetscScalar *values); /** * Return the scalar product of two @@ -858,7 +858,7 @@ namespace PETScWrappers */ void do_set_add_operation (const unsigned int n_elements, const unsigned int *indices, - const PetscScalar *values, + const PetscScalar *values, const bool add_values); @@ -886,7 +886,7 @@ namespace PETScWrappers namespace internal { inline - VectorReference::VectorReference (const VectorBase &vector, + VectorReference::VectorReference (const VectorBase &vector, const unsigned int index) : vector (vector), diff --git a/deal.II/include/deal.II/lac/sparse_matrix.templates.h b/deal.II/include/deal.II/lac/sparse_matrix.templates.h index 767984fea2..f032403de4 100644 --- a/deal.II/include/deal.II/lac/sparse_matrix.templates.h +++ b/deal.II/include/deal.II/lac/sparse_matrix.templates.h @@ -92,7 +92,7 @@ SparseMatrix::SparseMatrix (const SparsityPattern &c) template SparseMatrix::SparseMatrix (const SparsityPattern &c, - const IdentityMatrix &id) + const IdentityMatrix &id) : cols(0, "SparseMatrix"), val(0), @@ -177,7 +177,7 @@ SparseMatrix::operator = (const double d) template SparseMatrix & -SparseMatrix::operator= (const IdentityMatrix &id) +SparseMatrix::operator= (const IdentityMatrix &id) { Assert (cols->n_rows() == id.m(), ExcDimensionMismatch (cols->n_rows(), id.m())); @@ -393,7 +393,7 @@ namespace internal void vmult_on_subrange (const unsigned int begin_row, const unsigned int end_row, const number *values, - const std::size_t *rowstart, + const std::size_t *rowstart, const unsigned int *colnums, const InVector &src, OutVector &dst, @@ -778,7 +778,7 @@ namespace internal number matrix_norm_sqr_on_subrange (const unsigned int begin_row, const unsigned int end_row, const number *values, - const std::size_t *rowstart, + const std::size_t *rowstart, const unsigned int *colnums, const InVector &v) { @@ -841,7 +841,7 @@ namespace internal number matrix_scalar_product_on_subrange (const unsigned int begin_row, const unsigned int end_row, const number *values, - const std::size_t *rowstart, + const std::size_t *rowstart, const unsigned int *colnums, const InVector &u, const InVector &v) @@ -1266,7 +1266,7 @@ namespace internal number residual_sqr_on_subrange (const unsigned int begin_row, const unsigned int end_row, const number *values, - const std::size_t *rowstart, + const std::size_t *rowstart, const unsigned int *colnums, const InVector &u, const InVector &b, @@ -1336,7 +1336,7 @@ SparseMatrix::precondition_Jacobi (Vector &dst, const unsigned int n = src.size(); somenumber *dst_ptr = dst.begin(); const somenumber *src_ptr = src.begin(); - const std::size_t *rowstart_ptr = &cols->rowstart[0]; + const std::size_t *rowstart_ptr = &cols->rowstart[0]; // optimize the following loop for // the case that the relaxation @@ -1380,7 +1380,7 @@ SparseMatrix::precondition_SSOR (Vector &dst, Assert (src.size() == n(), ExcDimensionMismatch (src.size(), n())); const unsigned int n = src.size(); - const std::size_t *rowstart_ptr = &cols->rowstart[0]; + const std::size_t *rowstart_ptr = &cols->rowstart[0]; somenumber *dst_ptr = &dst(0); // case when we have stored the position diff --git a/deal.II/include/deal.II/lac/trilinos_block_vector.h b/deal.II/include/deal.II/lac/trilinos_block_vector.h index 1bea6bebaf..8c898ed3bb 100644 --- a/deal.II/include/deal.II/lac/trilinos_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_block_vector.h @@ -134,7 +134,7 @@ namespace TrilinosWrappers * of the given input vector and copy * the elements. */ - BlockVector (const BlockVector &V); + BlockVector (const BlockVector &V); /** * Creates a block vector diff --git a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h index fd80a509dc..34b7bd28e3 100644 --- a/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -128,7 +128,7 @@ namespace TrilinosWrappers * to those of the given argument and * copy the elements. */ - BlockVector (const BlockVector &V); + BlockVector (const BlockVector &V); /** * Creates a block vector diff --git a/deal.II/include/deal.II/lac/trilinos_solver.h b/deal.II/include/deal.II/lac/trilinos_solver.h index 57c3798338..7460a835a8 100644 --- a/deal.II/include/deal.II/lac/trilinos_solver.h +++ b/deal.II/include/deal.II/lac/trilinos_solver.h @@ -120,7 +120,7 @@ namespace TrilinosWrappers * solver control object and * creates the solver. */ - SolverBase (SolverControl &cn); + SolverBase (SolverControl &cn); /** * Second constructor. This @@ -555,7 +555,7 @@ namespace TrilinosWrappers * solver control object and * creates the solver. */ - SolverDirect (SolverControl &cn, + SolverDirect (SolverControl &cn, const AdditionalData &data = AdditionalData()); /** diff --git a/deal.II/include/deal.II/lac/vector.templates.h b/deal.II/include/deal.II/lac/vector.templates.h index 966727d927..e7f981240d 100644 --- a/deal.II/include/deal.II/lac/vector.templates.h +++ b/deal.II/include/deal.II/lac/vector.templates.h @@ -498,7 +498,7 @@ namespace internal struct InnerProd { Number - operator() (const Number *&X, const Number2 *&Y, const Number &) const + operator() (const Number *&X, const Number2 *&Y, const Number &) const { return *X++ * Number(numbers::NumberTraits::conjugate(*Y++)); }