Reference documentation for deal.II version GIT relicensing-437-g81ec864850 2024-04-19 07:30:02+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Namespaces | Functions
data_out_base.cc File Reference
#include <deal.II/base/data_out_base.h>
#include <deal.II/base/memory_consumption.h>
#include <deal.II/base/mpi.h>
#include <deal.II/base/mpi_large_count.h>
#include <deal.II/base/parameter_handler.h>
#include <deal.II/base/thread_management.h>
#include <deal.II/base/utilities.h>
#include <deal.II/numerics/data_component_interpretation.h>
#include <algorithm>
#include <cmath>
#include <cstdint>
#include <cstring>
#include <ctime>
#include <fstream>
#include <iomanip>
#include <limits>
#include <memory>
#include <set>
#include <sstream>
#include <vector>
#include <zlib.h>
#include <hdf5.h>
#include <boost/iostreams/copy.hpp>
#include <boost/iostreams/device/back_inserter.hpp>
#include <boost/iostreams/filtering_stream.hpp>
#include <boost/iostreams/filter/zlib.hpp>
#include "data_out_base.inst"

Go to the source code of this file.

Namespaces

namespace  DataOutBase
 
namespace  DataOutBaseImplementation
 

Functions

OutputFormat DataOutBase::parse_output_format (const std::string &format_name)
 
std::string DataOutBase::get_output_format_names ()
 
std::string DataOutBase::default_suffix (const OutputFormat output_format)
 
template<int dim, int spacedim>
std::vector< Point< spacedim > > DataOutBase::get_node_positions (const std::vector< Patch< dim, spacedim > > &patches)
 
template<int dim, int spacedim, typename StreamType >
void DataOutBase::write_nodes (const std::vector< Patch< dim, spacedim > > &patches, StreamType &out)
 
template<int dim, int spacedim, typename StreamType >
void DataOutBase::write_cells (const std::vector< Patch< dim, spacedim > > &patches, StreamType &out)
 
template<int dim, int spacedim, typename StreamType >
void DataOutBase::write_high_order_cells (const std::vector< Patch< dim, spacedim > > &patches, StreamType &out, const bool legacy_format)
 
template<int dim, int spacedim, typename StreamType >
void DataOutBase::write_data (const std::vector< Patch< dim, spacedim > > &patches, unsigned int n_data_sets, const bool double_precision, StreamType &out)
 
template<int dim, int spacedim>
void DataOutBase::write_ucd (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const UcdFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_dx (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const DXFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_gnuplot (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const GnuplotFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_povray (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const PovrayFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_eps (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const EpsFlags &flags, std::ostream &out)
 
template<int spacedim>
void DataOutBase::write_eps (const std::vector< Patch< 2, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const EpsFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_gmv (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const GmvFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_tecplot (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const TecplotFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_vtk (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const VtkFlags &flags, std::ostream &out)
 
void DataOutBase::write_vtu_header (std::ostream &out, const VtkFlags &flags)
 
void DataOutBase::write_vtu_footer (std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_vtu (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const VtkFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_vtu_main (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const VtkFlags &flags, std::ostream &out)
 
void DataOutBase::write_pvtu_record (std::ostream &out, const std::vector< std::string > &piece_names, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const VtkFlags &flags)
 
void DataOutBase::write_pvd_record (std::ostream &out, const std::vector< std::pair< double, std::string > > &times_and_names)
 
void DataOutBase::write_visit_record (std::ostream &out, const std::vector< std::string > &piece_names)
 
void DataOutBase::write_visit_record (std::ostream &out, const std::vector< std::vector< std::string > > &piece_names)
 
void DataOutBase::write_visit_record (std::ostream &out, const std::vector< std::pair< double, std::vector< std::string > > > &times_and_piece_names)
 
template<int dim, int spacedim>
void DataOutBase::write_svg (const std::vector< Patch< dim, spacedim > > &, const std::vector< std::string > &, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &, const SvgFlags &, std::ostream &)
 
template<int spacedim>
void DataOutBase::write_svg (const std::vector< Patch< 2, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const SvgFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_deal_II_intermediate (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const Deal_II_IntermediateFlags &flags, std::ostream &out)
 
template<int dim, int spacedim>
void DataOutBase::write_deal_II_intermediate_in_parallel (const std::vector< Patch< dim, spacedim > > &patches, const std::vector< std::string > &data_names, const std::vector< std::tuple< unsigned int, unsigned int, std::string, DataComponentInterpretation::DataComponentInterpretation > > &nonscalar_data_ranges, const Deal_II_IntermediateFlags &flags, const std::string &filename, const MPI_Comm comm, const CompressionLevel compression)
 
std::pair< unsigned int, unsigned intDataOutBase::determine_intermediate_format_dimensions (std::istream &input)
 
template<int dim, int spacedim>
std::ostream & DataOutBase::operator<< (std::ostream &out, const Patch< dim, spacedim > &patch)
 
template<int dim, int spacedim>
std::istream & DataOutBase::operator>> (std::istream &in, Patch< dim, spacedim > &patch)
 

Variable Documentation

◆ center

Point<3> center

Definition at line 267 of file data_out_base.cc.

◆ vertices

Point<2> vertices[4]

Vector of vertices of this cell (three-dimensional)

Vector of vertices of this cell.

Definition at line 272 of file data_out_base.cc.

◆ depth

float depth

Depth into the picture, which is defined as the distance from an observer at an the origin in direction of the line of sight.

Definition at line 278 of file data_out_base.cc.

◆ projected_vertices

Point<2> projected_vertices[4]

Vector of vertices of this cell (projected, two-dimensional).

Definition at line 283 of file data_out_base.cc.

◆ projected_center

Point<2> projected_center

Definition at line 286 of file data_out_base.cc.

◆ color_value

float color_value

Data value from which the actual colors will be computed by the colorization function stated in the EpsFlags class.

Definition at line 321 of file data_out_base.cc.