From: David Wells Date: Thu, 12 Nov 2015 20:28:30 +0000 (-0500) Subject: Prefer StreamType to STREAM. X-Git-Tag: v8.4.0-rc2~230^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=59381ceb766f5f2b750b34d0a7d37d558ec9997f;p=dealii.git Prefer StreamType to STREAM. --- diff --git a/include/deal.II/algorithms/any_data.h b/include/deal.II/algorithms/any_data.h index 7b31146f50..b4f9a43fe5 100644 --- a/include/deal.II/algorithms/any_data.h +++ b/include/deal.II/algorithms/any_data.h @@ -167,8 +167,8 @@ public: bool is_type(const unsigned int i) const; /// List the contents to a stream - template - void list (STREAM &os) const; + template + void list (StreamType &os) const; /// An entry with this name does not exist in the AnyData object. DeclException1(ExcNameNotFound, std::string, @@ -448,9 +448,9 @@ AnyData::merge(const AnyData &other) } -template +template inline -void AnyData::list(STREAM &os) const +void AnyData::list(StreamType &os) const { for (unsigned int i=0; i - void print(STREAM &out) const; + template + void print(StreamType &out) const; /** * Writes the IndexSet into a text based file format, that can be read in @@ -1563,10 +1563,10 @@ IndexSet::fill_binary_vector (Vector &vector) const -template +template inline void -IndexSet::print (STREAM &out) const +IndexSet::print (StreamType &out) const { compress(); out << "{"; diff --git a/include/deal.II/base/path_search.h b/include/deal.II/base/path_search.h index 7df32ecaf9..94ec30f925 100644 --- a/include/deal.II/base/path_search.h +++ b/include/deal.II/base/path_search.h @@ -149,8 +149,8 @@ public: /** * Show the paths and suffixes used for this object. */ - template - void show(STREAM &stream) const; + template + void show(StreamType &stream) const; /** * Add a new class. @@ -252,10 +252,10 @@ private: /* ----------------------------- inline functions ------------------------- */ -template +template inline void -PathSearch::show(STREAM &out) const +PathSearch::show(StreamType &out) const { out << "DEAL_II_" << cls << "PATH=\""; bool first = true; diff --git a/include/deal.II/base/polynomial_space.h b/include/deal.II/base/polynomial_space.h index 8853bf40d8..6ff52953ca 100644 --- a/include/deal.II/base/polynomial_space.h +++ b/include/deal.II/base/polynomial_space.h @@ -116,8 +116,8 @@ public: /** * Prints the list of the indices to out. */ - template - void output_indices(STREAM &out) const; + template + void output_indices(StreamType &out) const; /** * Sets the ordering of the polynomials. Requires @@ -299,9 +299,9 @@ PolynomialSpace::degree() const template -template +template void -PolynomialSpace::output_indices(STREAM &out) const +PolynomialSpace::output_indices(StreamType &out) const { unsigned int ix[dim]; for (unsigned int i=0; i - void print_data(STREAM &stream) const; + template + void print_data(StreamType &stream) const; #endif @@ -685,10 +685,10 @@ Timer::get_data() const -template +template inline void -Timer::print_data(STREAM &stream) const +Timer::print_data(StreamType &stream) const { unsigned int my_id = dealii::Utilities::MPI::this_mpi_process(mpi_communicator); if (my_id==0) diff --git a/include/deal.II/fe/fe_update_flags.h b/include/deal.II/fe/fe_update_flags.h index 52afc20b5c..84d473ddff 100644 --- a/include/deal.II/fe/fe_update_flags.h +++ b/include/deal.II/fe/fe_update_flags.h @@ -243,9 +243,9 @@ enum UpdateFlags * * @ref UpdateFlags */ -template +template inline -STREAM &operator << (STREAM &s, UpdateFlags u) +StreamType &operator << (StreamType &s, UpdateFlags u) { s << " UpdateFlags|"; if (u & update_values) s << "values|"; diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index 094dc8e54e..335a7c5416 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -473,8 +473,8 @@ public: * Print the iterator to a stream out. The format is * level.index. */ - template - void print (STREAM &out) const; + template + void print (StreamType &out) const; /** @@ -1059,10 +1059,10 @@ TriaRawIterator::operator -- () template -template +template inline void -TriaRawIterator::print (STREAM &out) const +TriaRawIterator::print (StreamType &out) const { if (Accessor::structure_dimension==Accessor::dimension) out << accessor.level() << "." << accessor.index(); diff --git a/include/deal.II/lac/block_matrix_array.h b/include/deal.II/lac/block_matrix_array.h index e99c2025f8..d60fecda85 100644 --- a/include/deal.II/lac/block_matrix_array.h +++ b/include/deal.II/lac/block_matrix_array.h @@ -252,8 +252,8 @@ public: * Nevertheless, the output at least gives some kind of idea of the block * structure of this matrix. */ - template - void print_latex (STREAM &out) const; + template + void print_latex (StreamType &out) const; protected: /** @@ -550,10 +550,10 @@ BlockMatrixArray::enter (const MatrixType &matrix, template -template +template inline void -BlockMatrixArray::print_latex (STREAM &out) const +BlockMatrixArray::print_latex (StreamType &out) const { out << "\\begin{array}{" << std::string(n_block_cols(), 'c') diff --git a/include/deal.II/lac/block_sparse_matrix_ez.h b/include/deal.II/lac/block_sparse_matrix_ez.h index 492b9310d1..1ef96a9ed5 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.h @@ -241,8 +241,8 @@ public: * existing row lengths and allocated row lengths. Otherwise, just the * relation of allocated and used entries is shown. */ - template - void print_statistics (STREAM &s, bool full = false); + template + void print_statistics (StreamType &s, bool full = false); private: /** @@ -478,10 +478,10 @@ Tvmult_add (BlockVector &dst, template -template +template inline void -BlockSparseMatrixEZ::print_statistics (STREAM &out, bool full) +BlockSparseMatrixEZ::print_statistics (StreamType &out, bool full) { size_type used_total = 0; size_type allocated_total = 0; diff --git a/include/deal.II/lac/full_matrix.h b/include/deal.II/lac/full_matrix.h index 0aadc96c7c..1d9be2c4df 100644 --- a/include/deal.II/lac/full_matrix.h +++ b/include/deal.II/lac/full_matrix.h @@ -566,8 +566,8 @@ public: * stream before setting these given values for output, and restores the * previous values after output. */ - template - void print (STREAM &s, + template + void print (StreamType &s, const unsigned int width=5, const unsigned int precision=2) const; @@ -1529,10 +1529,10 @@ FullMatrix::add (const size_type row, template -template +template inline void -FullMatrix::print (STREAM &s, +FullMatrix::print (StreamType &s, const unsigned int w, const unsigned int p) const { diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index ba07c37118..27d868e3c6 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -1428,10 +1428,10 @@ public: * internal storage scheme. If it is false, the elements in a row are * written in ascending column order. */ - template - void print (STREAM &out, - const bool across = false, - const bool diagonal_first = true) const; + template + void print (StreamType &out, + const bool across = false, + const bool diagonal_first = true) const; /** * Print the matrix in the usual format, i.e. as a matrix and not as a list @@ -2340,11 +2340,11 @@ SparseMatrix::end (const size_type r) template -template +template inline -void SparseMatrix::print (STREAM &out, - const bool across, - const bool diagonal_first) const +void SparseMatrix::print (StreamType &out, + const bool across, + const bool diagonal_first) const { Assert (cols != 0, ExcNotInitialized()); Assert (val != 0, ExcNotInitialized()); diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index b75558a04d..153b5a8ede 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -406,8 +406,8 @@ public: * existing row lengths and allocated row lengths. Otherwise, just the * relation of allocated and used entries is shown. */ - template - void print_statistics (STREAM &s, bool full = false); + template + void print_statistics (StreamType &s, bool full = false); /** * Compute numbers of entries. @@ -1558,10 +1558,10 @@ SparseMatrixEZ::conjugate_add (const MatrixTypeA &A, template -template +template inline void -SparseMatrixEZ::print_statistics(STREAM &out, bool full) +SparseMatrixEZ::print_statistics(StreamType &out, bool full) { size_type used; size_type allocated; diff --git a/include/deal.II/matrix_free/dof_info.h b/include/deal.II/matrix_free/dof_info.h index bd306c205b..49d2599ba2 100644 --- a/include/deal.II/matrix_free/dof_info.h +++ b/include/deal.II/matrix_free/dof_info.h @@ -282,8 +282,8 @@ namespace internal * Prints a detailed summary of memory consumption in the different * structures of this class to the given output stream. */ - template - void print_memory_consumption(STREAM &out, + template + void print_memory_consumption(StreamType &out, const SizeInfo &size_info) const; /** diff --git a/include/deal.II/matrix_free/dof_info.templates.h b/include/deal.II/matrix_free/dof_info.templates.h index c57472054b..33789b3ccf 100644 --- a/include/deal.II/matrix_free/dof_info.templates.h +++ b/include/deal.II/matrix_free/dof_info.templates.h @@ -1933,9 +1933,9 @@ not_connect: - template + template void - DoFInfo::print_memory_consumption (STREAM &out, + DoFInfo::print_memory_consumption (StreamType &out, const SizeInfo &size_info) const { out << " Memory row starts indices: "; diff --git a/include/deal.II/matrix_free/helper_functions.h b/include/deal.II/matrix_free/helper_functions.h index c63776aa64..f828027476 100644 --- a/include/deal.II/matrix_free/helper_functions.h +++ b/include/deal.II/matrix_free/helper_functions.h @@ -101,8 +101,8 @@ namespace internal * Prints minimum, average, and maximal memory consumption over the MPI * processes. */ - template - void print_memory_statistics (STREAM &out, + template + void print_memory_statistics (StreamType &out, std::size_t data_length) const; /** diff --git a/include/deal.II/matrix_free/mapping_info.h b/include/deal.II/matrix_free/mapping_info.h index 906e2ae6ad..c47feef745 100644 --- a/include/deal.II/matrix_free/mapping_info.h +++ b/include/deal.II/matrix_free/mapping_info.h @@ -116,8 +116,8 @@ namespace internal * Prints a detailed summary of memory consumption in the different * structures of this class to the given output stream. */ - template - void print_memory_consumption(STREAM &out, + template + void print_memory_consumption(StreamType &out, const SizeInfo &size_info) const; /** @@ -274,8 +274,8 @@ namespace internal * Prints a detailed summary of memory consumption in the different * structures of this class to the given output stream. */ - template - void print_memory_consumption(STREAM &out, + template + void print_memory_consumption(StreamType &out, const SizeInfo &size_info) const; /** diff --git a/include/deal.II/matrix_free/mapping_info.templates.h b/include/deal.II/matrix_free/mapping_info.templates.h index 1c68ab104e..6e9e0ff8cb 100644 --- a/include/deal.II/matrix_free/mapping_info.templates.h +++ b/include/deal.II/matrix_free/mapping_info.templates.h @@ -856,9 +856,9 @@ namespace internal template - template + template void MappingInfo::MappingInfoDependent::print_memory_consumption - (STREAM &out, + (StreamType &out, const SizeInfo &size_info) const { // print_memory_statistics involves global communication, so we can @@ -901,8 +901,8 @@ namespace internal template - template - void MappingInfo::print_memory_consumption(STREAM &out, + template + void MappingInfo::print_memory_consumption(StreamType &out, const SizeInfo &size_info) const { out << " Cell types: "; diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 4e63fbf8c0..4ef90dd6f6 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -730,8 +730,8 @@ public: * Prints a detailed summary of memory consumption in the different * structures of this class to the given output stream. */ - template - void print_memory_consumption(STREAM &out) const; + template + void print_memory_consumption(StreamType &out) const; /** * Prints a summary of this class to the given output stream. It is focused diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 68b6a8a71d..575fbba5b7 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -772,8 +772,8 @@ std::size_t MatrixFree::memory_consumption () const template -template -void MatrixFree::print_memory_consumption (STREAM &out) const +template +void MatrixFree::print_memory_consumption (StreamType &out) const { out << " Memory cell FE operator total: --> "; size_info.print_memory_statistics (out, memory_consumption()); @@ -890,8 +890,8 @@ namespace internal - template - void SizeInfo::print_memory_statistics (STREAM &out, + template + void SizeInfo::print_memory_statistics (StreamType &out, std::size_t data_length) const { Utilities::MPI::MinMaxAvg memory_c diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index 637103a126..d9427c0d92 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -349,8 +349,8 @@ namespace MeshWorker */ void reinit(const BlockIndices &local_sizes); - template - void print_debug(STREAM &os) const; + template + void print_debug(StreamType &os) const; /** * The memory used by this object. @@ -640,9 +640,9 @@ namespace MeshWorker template - template + template void - LocalResults::print_debug(STREAM &os) const + LocalResults::print_debug(StreamType &os) const { os << "J: " << J.size() << std::endl; os << "R: " << R.size() << std::endl; diff --git a/include/deal.II/meshworker/vector_selector.h b/include/deal.II/meshworker/vector_selector.h index f4ba7ff549..0aea12eece 100644 --- a/include/deal.II/meshworker/vector_selector.h +++ b/include/deal.II/meshworker/vector_selector.h @@ -134,14 +134,14 @@ namespace MeshWorker /** * Print the contents of the selection to the stream. */ - template - void print (STREAM &s, const AnyData &v) const; + template + void print (StreamType &s, const AnyData &v) const; /** * Print the number of selections to the stream. */ - template - void print (STREAM &s) const; + template + void print (StreamType &s) const; /** * The memory used by this object. @@ -496,9 +496,9 @@ namespace MeshWorker } - template + template inline void - VectorSelector::print(STREAM &s) const + VectorSelector::print(StreamType &s) const { s << "values: " << n_values() << " gradients: " << n_gradients() @@ -507,9 +507,9 @@ namespace MeshWorker } - template + template inline void - VectorSelector::print(STREAM &s, const AnyData &v) const + VectorSelector::print(StreamType &s, const AnyData &v) const { s << "values: "; for (unsigned int i=0; i + template void write_nodes (const std::vector > &patches, - STREAM &out) + StreamType &out) { Assert (dim<=3, ExcNotImplemented()); unsigned int count = 0; @@ -2168,10 +2168,10 @@ namespace DataOutBase out.flush_points (); } - template + template void write_cells (const std::vector > &patches, - STREAM &out) + StreamType &out) { Assert (dim<=3, ExcNotImplemented()); unsigned int count = 0; @@ -2210,13 +2210,13 @@ namespace DataOutBase } - template + template void - write_data ( - const std::vector > &patches, - unsigned int n_data_sets, - const bool double_precision, - STREAM &out) + write_data + (const std::vector > &patches, + unsigned int n_data_sets, + const bool double_precision, + StreamType &out) { Assert (dim<=3, ExcNotImplemented()); unsigned int count = 0;