*
* </ul>
*
+ * @ingroup IO
* @author Wolfgang Bangerth, Guido Kanschat 1999, 2000, 2001, 2002, 2005.
*/
class DataOutBase
* | | | | |
* |__|__|__|__|
* @endverbatim
+ * @ingroup IO
* @author Wolfgang Bangerth
*/
template <int dim, int spacedim=dim>
};
/**
- * Flags describing the details of
- * output in OpenDX format. At
- * present no flags are implemented.
+ * Flags controlling the details of
+ * output in OpenDX format.
+ *
+ * @ingroup IO
*/
struct DXFlags
{
/**
- * Write neighbor information.
+ * Write neighbor
+ * information. This
+ * information is necessary
+ * for instance, if OpenDX is
+ * supposed to compute
+ * integral curves
+ * (streamlines). If it is
+ * not present, streamlines
+ * end at cell boundaries.
*/
bool write_neighbors;
};
/**
- * Flags describing the details of
+ * Flags controlling the details of
* output in UCD format.
+ *
+ * @ingroup IO
*/
struct UcdFlags
{
};
/**
- * Flags describing the details of
+ * Flags controlling the details of
* output in Gnuplot format. At
* present no flags are implemented.
+ *
+ * @ingroup IO
*/
struct GnuplotFlags
{
};
/**
- * Flags describing the details
+ * Flags controlling the details
* of output in Povray
* format. Several flags are
* implemented, see their
* respective documentation.
+ *
+ * @ingroup IO
*/
struct PovrayFlags
{
/**
- * Flags describing the details of
+ * Flags controlling the details of
* output in encapsulated postscript
* format.
+ *
+ * @ingroup IO
*/
struct EpsFlags
{
};
/**
- * Flags describing the details of
+ * Flags controlling the details of
* output in gmv format. At
* present no flags are implemented.
+ *
+ * @ingroup IO
*/
struct GmvFlags
{
};
/**
- * Flags describing the details of
- * output in Tecplot format. At
- * present no flags are implemented.
+ * Flags controlling the details of
+ * output in Tecplot format.
+ *
+ * @ingroup IO
*/
struct TecplotFlags
{
};
/**
- * Flags describing the details
+ * Flags controlling the details
* of output in VTK format. At
* present no flags are
* implemented.
+ *
+ * @ingroup IO
*/
struct VtkFlags
{
/**
- * Flags describing the details
+ * Flags controlling the details
* of output in deal.II
* intermediate format. At
* present no flags are
* implemented.
+ *
+ * @ingroup IO
*/
struct Deal_II_IntermediateFlags
{
* suffix for the output file name can be obtained by <tt>default_suffix</tt>
* without arguments.
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 1999
*/
template <int dim, int spacedim=dim>
* function is explained in step-19.
*
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 2005
*/
template <int dim, int spacedim=dim>
* that class if you experience unexpected problems when reading grids
* through this class.
*
+ * @ingroup grid
+ * @ingroup IO
* @author Wolfgang Bangerth, 1998, 2000, Luca Heltai, 2004
*/
template <int dim>
* modify the default outfit of the grids written into a file. See the
* different subclasses and the documentation of the GridOut
* class for more details.
+ *
+ * @ingroup IO
*/
namespace GridOutFlags
{
/**
* Flags for grid output in OpenDX format.
+ *
+ * @ingroup IO
*/
struct DX
{
/**
* Flags describing the details of
* output in UCD format.
+ *
+ * @ingroup IO
*/
struct Ucd
{
/**
* Flags describing the details of
* output in GNUPLOT format.
+ *
+ * @ingroup IO
*/
struct Gnuplot
{
* By default, the size of the picture
* is scaled such that the width equals
* 300 units.
+ *
+ * @ingroup IO
*/
struct EpsFlagsBase
{
* exist, we only here declare the
* general template and declare
* explicit specializations below.
- */
+ *
+ * @ingroup IO
+ */
template <int dim>
struct Eps
{};
/**
* Flags specific to the output of
* grids in one space dimensions.
+ *
+ * @ingroup IO
*/
template <>
struct Eps<1> : public EpsFlagsBase
/**
* Flags specific to the output of
* grids in two space dimensions.
+ *
+ * @ingroup IO
*/
template <>
struct Eps<2> : public EpsFlagsBase
/**
* Flags specific to the output of
* grids in three space dimensions.
+ *
+ * @ingroup IO
*/
template <>
struct Eps<3> : public EpsFlagsBase
};
/**
* Flags for XFig output.
+ *
+ * @ingroup IO
*/
struct XFig
{
* different formats. See the enum GridOut::OutputFormat for a list of formats
* and the corresponding output function names.
*
- * @sect3{Usage}
* Usage is simple: either you use the direct form
* @verbatim
* ofstream output_file("some_filename");
* dimensions supported by this class; they then have a template parameter,
* as usual.
*
- *
+ * @ingroup grid
+ * @ingroup IO
* @author Wolfgang Bangerth, Guido Kanschat, 1999, 2003; postscript format based on an implementation by Stefan Nauber, 1999
*/
class GridOut
* the triangulation from this data using the
* Triangulation::create_triangulation() function.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 2000, Michael Anderson 2003, Ralf Hartmann 2005
*/
template <int dim>
* cell that contains a given point. See the descriptions of the
* individual functions for more information.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 2001, 2003, 2004
*/
class GridTools
* later reconstruction and does also not touch the coarse grid which is
* used within restore().
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999
*/
template <int dim>
* <tt>Triangulation<dim>::create_triangulation</tt> function. It
* contains all data needed to construct a cell, namely the indices
* of the vertices and the material indicator.
+ *
+ * @ingroup grid
*/
template <int dim>
struct CellData
* (if in the interior). Explicitely giving a line the indicator 255
* will result in an error, as well as giving an interior line a boundary
* indicator.
+ *
+ * @ingroup grid
*/
struct SubCellData
{
* Note: these class should be made local to the triangulation class
* once the compiler supports that (gcc2.95 does not at present).
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999
*/
template <int dim>
* Note: these class should be made local to the triangulation class
* once the compiler supports that (gcc2.95 does not at present).
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999
*/
template <>
* Note: these class should be made local to the triangulation class
* once the compiler supports that (gcc2.95 does not at present).
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999
*/
template <>
* Note: these class should be made local to the triangulation class
* once the compiler supports that (gcc2.95 does not at present).
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999
*/
template <>
* HyperBallBoundary creating a hyperball with given radius
* around a given center point.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1999, 2001, Ralf Hartmann, 2001
*/
template <int dim>
* within a hexahedron, refer to the documentation of the
* Triangulation class.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
class Hexahedron
* @ref TriaDimensionInfo<1>
* @ref TriaDimensionInfo<2>
* @ref TriaDimensionInfo<3>
+ * @ingroup grid
* @ingroup Iterators
* @author Wolfgang Bangerth, 1998
* @author documentation update Guido Kanschat, 2004
* This specialization of TriaRawIterator provides access only to
* the <em>used</em> lines, quads, cells, etc.
*
+ * @ingroup grid
* @ingroup Iterators
*/
template <int dim, typename Accessor>
* cell which is not refined and thus a cell on which calculations
* on the finest level are done.
*
+ * @ingroup grid
* @ingroup Iterators
*/
template <int dim, typename Accessor>
/**
* Namespace in which an enumeration is declared that denotes the
* states in which an iterator can be in.
+ *
+ * @ingroup Iterators
*/
namespace IteratorState
{
* General template for information belonging to one level of a multilevel
* hierarchy of a triangulation. This template is only declared to allow
* specializations for different dimensions.
+ *
+ * @ingroup grid
*/
template <int dim>
class TriangulationLevel
* for the lines. Since we only store one byte per line, quad or hex,
* this is a minor loss and we can live with that.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
template <>
* The TriangulationsLevel objects of higher dimensions are derived from
* this one.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
template <>
* The vector of lines and their children is derived from
* TriangulationLevel<1>.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
template <>
* The vectors of lines and quads and their children are derived from
* TriangulationLevel<2>.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998, 2003
*/
template <>
* it belongs to. The level index is implicitly given by the position
* in the <tt>lines.lines</tt> list attached to the information of each level.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
class Line
* in the <tt>quads.quads</tt> list attached to the information of each level
* of the triangulation.
*
+ * @ingroup grid
* @author Wolfgang Bangerth, 1998
*/
class Quad
* be written in any of the implemented data formats.
*
*
- * @sect3{User visible interface}
+ * <h3>User visible interface</h3>
*
* The user visible interface of this class consists of functions which allow
* a user to make a DoFHandler object known to this class and to add data
* triangulation, so that the last template parameter has the same
* value as the second one.
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 1999
*/
template <int dof_handler_dim, int patch_dim, int patch_space_dim=patch_dim>
* the patches.
*
*
- * @sect3{User interface information}
+ * <h3>User interface information</h3>
*
* The base classes of this class, DataOutBase, DataOutInterface and
* DataOut_DoFData() offer several interfaces of their own. Refer to the
* output.
*
*
- * @sect3{Extensions}
+ * <h3>Extensions</h3>
*
* By default, this class produces patches for all active cells. Sometimes,
* this is not what you want, maybe because they are simply too many (and too
* this pair of functions and they return a non-active cell, then an exception
* will be thrown.
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 1999
*/
template <int dim>
* be generated. These patches can then be written in several
* graphical data formats by the functions of the underlying classes.
*
- * @sect3{Interface}
+ * <h3>Interface</h3>
*
* The interface of this class is copied from the DataOut
* class. Furthermore, they share the common parent class
* discussion of the interface.
*
*
- * @sect3{Extending this class}
+ * <h3>Extending this class</h3>
*
* The sequence of faces to generate patches from is generated in the
* same way as in the DataOut class, see there for a description
* applications certainly exist, for which the author is not
* imaginative enough.
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 2000
*/
template <int dim>
* produces <em>very</em> large output files.
*
*
- * @sect3{Interface}
+ * <h3>Interface</h3>
*
* The interface of this class is copied from the DataOut
* class. Furthermore, they share the common parent class
* further classes from this class.
*
*
- * @sect3{Details for 1d computations}
+ * <h3>Details for 1d computations</h3>
*
* The one coordinate in the triangulation used by the
* DoFHandler object passed to this class is taken as the radial
* radial coordinate only attains non-negative values.
*
*
- * @sect3{Details for 2d computations}
+ * <h3>Details for 2d computations</h3>
*
* We consider the computation (represented by the DoFHandler
* object that is attached to this class) to have happened in the
* It is in the responsibility of the user to make sure that the
* radial variable attains only non-negative values.
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 2000
*/
template <int dim>
* interpolations in time may be added in the future.
*
*
- * @sect2{Example of Use}
+ * <h3>Example of Use</h3>
*
* The following little example shall illustrate the different steps
* of use of this class. It is assumed that the finite element used is
* };
* @endverbatim
*
+ * @ingroup IO
* @author Wolfgang Bangerth, 1999
*/
template <int dim>
* written as a finite element field using the DataOut class.
* Please note that this class may produce enormous amounts of data!
*
+ * @ingroup IO
* @author Guido Kanschat, 2000
*/
template<int dim, class SOLVER, class VECTOR = Vector<double> >
* All other classes in this module actually implement quadrature
* rules of different order and other characteristics.
*/
+
+/**
+ * @defgroup IO Input/Output
+ *
+ * This module collects the classes used for reading and writing
+ * meshes and data.
+ */