bool is_type(const unsigned int i) const;
/// List the contents to a stream
- template <class STREAM>
- void list (STREAM &os) const;
+ template <class StreamType>
+ void list (StreamType &os) const;
/// An entry with this name does not exist in the AnyData object.
DeclException1(ExcNameNotFound, std::string,
}
-template <class STREAM>
+template <class StreamType>
inline
-void AnyData::list(STREAM &os) const
+void AnyData::list(StreamType &os) const
{
for (unsigned int i=0; i<names.size(); ++i)
{
* Outputs a text representation of this IndexSet to the given stream. Used
* for testing.
*/
- template <class STREAM>
- void print(STREAM &out) const;
+ template <class StreamType>
+ void print(StreamType &out) const;
/**
* Writes the IndexSet into a text based file format, that can be read in
-template <class STREAM>
+template <class StreamType>
inline
void
-IndexSet::print (STREAM &out) const
+IndexSet::print (StreamType &out) const
{
compress();
out << "{";
/**
* Show the paths and suffixes used for this object.
*/
- template <class STREAM>
- void show(STREAM &stream) const;
+ template <class StreamType>
+ void show(StreamType &stream) const;
/**
* Add a new class.
/* ----------------------------- inline functions ------------------------- */
-template <class STREAM>
+template <class StreamType>
inline
void
-PathSearch::show(STREAM &out) const
+PathSearch::show(StreamType &out) const
{
out << "DEAL_II_" << cls << "PATH=\"";
bool first = true;
/**
* Prints the list of the indices to <tt>out</tt>.
*/
- template <class STREAM>
- void output_indices(STREAM &out) const;
+ template <class StreamType>
+ void output_indices(StreamType &out) const;
/**
* Sets the ordering of the polynomials. Requires
template <int dim>
-template <class STREAM>
+template <class StreamType>
void
-PolynomialSpace<dim>::output_indices(STREAM &out) const
+PolynomialSpace<dim>::output_indices(StreamType &out) const
{
unsigned int ix[dim];
for (unsigned int i=0; i<n_pols; ++i)
/**
* Prints the data to the given stream.
*/
- template <class STREAM>
- void print_data(STREAM &stream) const;
+ template <class StreamType>
+ void print_data(StreamType &stream) const;
#endif
-template <class STREAM>
+template <class StreamType>
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)
*
* @ref UpdateFlags
*/
-template <class STREAM>
+template <class StreamType>
inline
-STREAM &operator << (STREAM &s, UpdateFlags u)
+StreamType &operator << (StreamType &s, UpdateFlags u)
{
s << " UpdateFlags|";
if (u & update_values) s << "values|";
* Print the iterator to a stream <code>out</code>. The format is
* <tt>level.index</tt>.
*/
- template <class STREAM>
- void print (STREAM &out) const;
+ template <class StreamType>
+ void print (StreamType &out) const;
/**
template <typename Accessor>
-template <class STREAM>
+template <class StreamType>
inline
void
-TriaRawIterator<Accessor>::print (STREAM &out) const
+TriaRawIterator<Accessor>::print (StreamType &out) const
{
if (Accessor::structure_dimension==Accessor::dimension)
out << accessor.level() << "." << accessor.index();
* Nevertheless, the output at least gives some kind of idea of the block
* structure of this matrix.
*/
- template <class STREAM>
- void print_latex (STREAM &out) const;
+ template <class StreamType>
+ void print_latex (StreamType &out) const;
protected:
/**
template <typename number, typename BlockVectorType>
-template <class STREAM>
+template <class StreamType>
inline
void
-BlockMatrixArray<number, BlockVectorType>::print_latex (STREAM &out) const
+BlockMatrixArray<number, BlockVectorType>::print_latex (StreamType &out) const
{
out << "\\begin{array}{"
<< std::string(n_block_cols(), 'c')
* existing row lengths and allocated row lengths. Otherwise, just the
* relation of allocated and used entries is shown.
*/
- template <class STREAM>
- void print_statistics (STREAM &s, bool full = false);
+ template <class StreamType>
+ void print_statistics (StreamType &s, bool full = false);
private:
/**
template <typename number>
-template <class STREAM>
+template <class StreamType>
inline
void
-BlockSparseMatrixEZ<number>::print_statistics (STREAM &out, bool full)
+BlockSparseMatrixEZ<number>::print_statistics (StreamType &out, bool full)
{
size_type used_total = 0;
size_type allocated_total = 0;
* stream before setting these given values for output, and restores the
* previous values after output.
*/
- template <class STREAM>
- void print (STREAM &s,
+ template <class StreamType>
+ void print (StreamType &s,
const unsigned int width=5,
const unsigned int precision=2) const;
template <typename number>
-template <class STREAM>
+template <class StreamType>
inline
void
-FullMatrix<number>::print (STREAM &s,
+FullMatrix<number>::print (StreamType &s,
const unsigned int w,
const unsigned int p) const
{
* internal storage scheme. If it is false, the elements in a row are
* written in ascending column order.
*/
- template <class STREAM>
- void print (STREAM &out,
- const bool across = false,
- const bool diagonal_first = true) const;
+ template <class StreamType>
+ 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
template <typename number>
-template <class STREAM>
+template <class StreamType>
inline
-void SparseMatrix<number>::print (STREAM &out,
- const bool across,
- const bool diagonal_first) const
+void SparseMatrix<number>::print (StreamType &out,
+ const bool across,
+ const bool diagonal_first) const
{
Assert (cols != 0, ExcNotInitialized());
Assert (val != 0, ExcNotInitialized());
* existing row lengths and allocated row lengths. Otherwise, just the
* relation of allocated and used entries is shown.
*/
- template <class STREAM>
- void print_statistics (STREAM &s, bool full = false);
+ template <class StreamType>
+ void print_statistics (StreamType &s, bool full = false);
/**
* Compute numbers of entries.
template <typename number>
-template <class STREAM>
+template <class StreamType>
inline
void
-SparseMatrixEZ<number>::print_statistics(STREAM &out, bool full)
+SparseMatrixEZ<number>::print_statistics(StreamType &out, bool full)
{
size_type used;
size_type allocated;
* Prints a detailed summary of memory consumption in the different
* structures of this class to the given output stream.
*/
- template <typename STREAM>
- void print_memory_consumption(STREAM &out,
+ template <typename StreamType>
+ void print_memory_consumption(StreamType &out,
const SizeInfo &size_info) const;
/**
- template <typename STREAM>
+ template <typename StreamType>
void
- DoFInfo::print_memory_consumption (STREAM &out,
+ DoFInfo::print_memory_consumption (StreamType &out,
const SizeInfo &size_info) const
{
out << " Memory row starts indices: ";
* Prints minimum, average, and maximal memory consumption over the MPI
* processes.
*/
- template <typename STREAM>
- void print_memory_statistics (STREAM &out,
+ template <typename StreamType>
+ void print_memory_statistics (StreamType &out,
std::size_t data_length) const;
/**
* Prints a detailed summary of memory consumption in the different
* structures of this class to the given output stream.
*/
- template <typename STREAM>
- void print_memory_consumption(STREAM &out,
+ template <typename StreamType>
+ void print_memory_consumption(StreamType &out,
const SizeInfo &size_info) const;
/**
* Prints a detailed summary of memory consumption in the different
* structures of this class to the given output stream.
*/
- template <typename STREAM>
- void print_memory_consumption(STREAM &out,
+ template <typename StreamType>
+ void print_memory_consumption(StreamType &out,
const SizeInfo &size_info) const;
/**
template <int dim, typename Number>
- template <typename STREAM>
+ template <typename StreamType>
void MappingInfo<dim,Number>::MappingInfoDependent::print_memory_consumption
- (STREAM &out,
+ (StreamType &out,
const SizeInfo &size_info) const
{
// print_memory_statistics involves global communication, so we can
template <int dim, typename Number>
- template <typename STREAM>
- void MappingInfo<dim,Number>::print_memory_consumption(STREAM &out,
+ template <typename StreamType>
+ void MappingInfo<dim,Number>::print_memory_consumption(StreamType &out,
const SizeInfo &size_info) const
{
out << " Cell types: ";
* Prints a detailed summary of memory consumption in the different
* structures of this class to the given output stream.
*/
- template <typename STREAM>
- void print_memory_consumption(STREAM &out) const;
+ template <typename StreamType>
+ void print_memory_consumption(StreamType &out) const;
/**
* Prints a summary of this class to the given output stream. It is focused
template <int dim, typename Number>
-template <typename STREAM>
-void MatrixFree<dim,Number>::print_memory_consumption (STREAM &out) const
+template <typename StreamType>
+void MatrixFree<dim,Number>::print_memory_consumption (StreamType &out) const
{
out << " Memory cell FE operator total: --> ";
size_info.print_memory_statistics (out, memory_consumption());
- template <typename STREAM>
- void SizeInfo::print_memory_statistics (STREAM &out,
+ template <typename StreamType>
+ void SizeInfo::print_memory_statistics (StreamType &out,
std::size_t data_length) const
{
Utilities::MPI::MinMaxAvg memory_c
*/
void reinit(const BlockIndices &local_sizes);
- template <class STREAM>
- void print_debug(STREAM &os) const;
+ template <class StreamType>
+ void print_debug(StreamType &os) const;
/**
* The memory used by this object.
template <typename number>
- template <class STREAM>
+ template <class StreamType>
void
- LocalResults<number>::print_debug(STREAM &os) const
+ LocalResults<number>::print_debug(StreamType &os) const
{
os << "J: " << J.size() << std::endl;
os << "R: " << R.size() << std::endl;
/**
* Print the contents of the selection to the stream.
*/
- template <class STREAM, typename DATA>
- void print (STREAM &s, const AnyData &v) const;
+ template <class StreamType, typename DATA>
+ void print (StreamType &s, const AnyData &v) const;
/**
* Print the number of selections to the stream.
*/
- template <class STREAM>
- void print (STREAM &s) const;
+ template <class StreamType>
+ void print (StreamType &s) const;
/**
* The memory used by this object.
}
- template <class STREAM>
+ template <class StreamType>
inline void
- VectorSelector::print(STREAM &s) const
+ VectorSelector::print(StreamType &s) const
{
s << "values: " << n_values()
<< " gradients: " << n_gradients()
}
- template <class STREAM, typename DATA>
+ template <class StreamType, typename DATA>
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<n_values(); ++i)
//----------------------------------------------------------------------//
- template <int dim, int spacedim, typename STREAM>
+ template <int dim, int spacedim, typename StreamType>
void
write_nodes (const std::vector<Patch<dim,spacedim> > &patches,
- STREAM &out)
+ StreamType &out)
{
Assert (dim<=3, ExcNotImplemented());
unsigned int count = 0;
out.flush_points ();
}
- template <int dim, int spacedim, typename STREAM>
+ template <int dim, int spacedim, typename StreamType>
void
write_cells (const std::vector<Patch<dim,spacedim> > &patches,
- STREAM &out)
+ StreamType &out)
{
Assert (dim<=3, ExcNotImplemented());
unsigned int count = 0;
}
- template <int dim, int spacedim, class STREAM>
+ template <int dim, int spacedim, class StreamType>
void
- write_data (
- const std::vector<Patch<dim,spacedim> > &patches,
- unsigned int n_data_sets,
- const bool double_precision,
- STREAM &out)
+ write_data
+ (const std::vector<Patch<dim,spacedim> > &patches,
+ unsigned int n_data_sets,
+ const bool double_precision,
+ StreamType &out)
{
Assert (dim<=3, ExcNotImplemented());
unsigned int count = 0;