*
* </ul>
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, Guido Kanschat 1999, 2000, 2001, 2002, 2005.
*/
class DataOutBase
* | | | | |
* |__|__|__|__|
* @endverbatim
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth
*/
template <int dim, int spacedim=dim>
* Flags controlling the details of
* output in OpenDX format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct DXFlags
{
* of output in UCD format for
* @ref SoftwareAVS.
*
- * @ingroup IO
+ * @ingroup output
*/
struct UcdFlags
{
* output in Gnuplot format. At
* present no flags are implemented.
*
- * @ingroup IO
+ * @ingroup output
*/
struct GnuplotFlags
{
* implemented, see their
* respective documentation.
*
- * @ingroup IO
+ * @ingroup output
*/
struct PovrayFlags
{
* output in encapsulated postscript
* format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct EpsFlags
{
* output in gmv format. At
* present no flags are implemented.
*
- * @ingroup IO
+ * @ingroup output
*/
struct GmvFlags
{
* of output in @ref
* SoftwareTecplot format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct TecplotFlags
{
* Flags controlling the details
* of output in VTK format. At
* present no flags are
- * implemented.
+ * implemented. See @ref SoftwareVTK.
*
- * @ingroup IO
+ * @ingroup output
*/
struct VtkFlags
{
* present no flags are
* implemented.
*
- * @ingroup IO
+ * @ingroup output
*/
struct Deal_II_IntermediateFlags
{
* format.
*/
tecplot_binary,
+
/**
* Output in VTK format.
+ * @ref SoftwareVTK
*/
vtk,
+
/**
* Output in deal.II
* intermediate format.
/**
* Write the given list of patches to the output stream for the <a
- * href="www.povray.org">povray</a> raytracer.
+ * href="http://www.povray.org">povray</a> raytracer.
*
* Output in this format creates a povray source file, include
* standard camera and light source definition for rendering with
* suffix for the output file name can be obtained by <tt>default_suffix</tt>
* without arguments.
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 1999
*/
template <int dim, int spacedim=dim>
* function is explained in step-19.
*
*
- * @ingroup IO
+ * @ingroup input output
* @author Wolfgang Bangerth, 2005
*/
template <int dim, int spacedim=dim>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
QIterated (const Quadrature<1> &base_quadrature,
const unsigned int n_copies);
- /** @addtogroup Exceptions
- * @{ */
/**
* Exception
*/
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <utility>
-/*!@addtogroup febase */
+/*!@addtogroup febase fe */
/*@{*/
/**
#include <vector>
#include <string>
-/*!@addtogroup febase */
+/*!@addtogroup feall */
/*@{*/
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/config.h>
-/*!@addtogroup febase */
+/*!@addtogroup feaccess */
/*@{*/
/**
//TODO: Offset in transform functions should be replaced by initializing VectorSlice correctly
-/*!@addtogroup febase */
-/*@{*/
/**
* Abstract base class for mapping classes.
* A hint to implementators: no function except the two functions
* @p update_once and @p update_each may add any flags.
*
+ * @ingroup mapping
* @author Guido Kanschat, Ralf Hartmann 2000, 2001
*/
template <int dim>
friend class FESubfaceValues<dim>;
};
-/*@}*/
/* ------------------------- inline functions ------------------------- */
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* through this class.
*
* @ingroup grid
- * @ingroup IO
+ * @ingroup input
* @author Wolfgang Bangerth, 1998, 2000, Luca Heltai, 2004
*/
template <int dim>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* different subclasses and the documentation of the GridOut
* class for more details.
*
- * @ingroup IO
+ * @ingroup output
*/
namespace GridOutFlags
{
/**
* Flags for grid output in OpenDX format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct DX
{
* Flags describing the details of
* output in UCD format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct Ucd
{
* Flags describing the details of
* output in GNUPLOT format.
*
- * @ingroup IO
+ * @ingroup output
*/
struct Gnuplot
{
* is scaled such that the width equals
* 300 units.
*
- * @ingroup IO
+ * @ingroup output
*/
struct EpsFlagsBase
{
* general template and declare
* explicit specializations below.
*
- * @ingroup IO
+ * @ingroup output
*/
template <int dim>
struct Eps
* Flags specific to the output of
* grids in one space dimensions.
*
- * @ingroup IO
+ * @ingroup output
*/
template <>
struct Eps<1> : public EpsFlagsBase
* Flags specific to the output of
* grids in two space dimensions.
*
- * @ingroup IO
+ * @ingroup output
*/
template <>
struct Eps<2> : public EpsFlagsBase
* Flags specific to the output of
* grids in three space dimensions.
*
- * @ingroup IO
+ * @ingroup output
*/
template <>
struct Eps<3> : public EpsFlagsBase
/**
* Flags for XFig output.
*
- * @ingroup IO
+ * @ingroup output
*/
struct XFig
{
* as usual.
*
* @ingroup grid
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, Guido Kanschat, 1999, 2003; postscript format based on an implementation by Stefan Nauber, 1999
*/
class GridOut
* triangulation, so that the last template parameter has the same
* value as the second one.
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 1999
*/
template <int dof_handler_dim, template <int> class DH,
* this pair of functions and they return a non-active cell, then an exception
* will be thrown.
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 1999
*/
template <int dim, template <int> class DH = DoFHandler>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* applications certainly exist, for which the author is not
* imaginative enough.
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 2000
*/
template <int dim, template <int> class DH = DoFHandler>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* It is in the responsibility of the user to make sure that the
* radial variable attains only non-negative values.
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 2000
*/
template <int dim, template <int> class DH = DoFHandler>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* };
* @endverbatim
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 1999
*/
template <int dim, template <int> class DH = DoFHandler>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* D d;
* @endverbatim
*
- * @ingroup IO
+ * @ingroup output
* @author Wolfgang Bangerth, 2001
*/
class MatrixOut : public DataOutInterface<2,2>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
-/*! @addtogroup Preconditioners
- *@{
- */
-
/**
* This class provides an interface to the sparse direct solver MA27
* from the Harwell Subroutine Library. MA27 is a direct solver
* seconds. After that time, the detached solver should have noticed
* the main programs demise.
*
+ * @ingroup Solvers Preconditioners
*
* @author Wolfgang Bangerth, 2000, 2001, 2002
*/
* A detached mode as for MA27 has not yet been implemented for this
* class.
*
+ *
+ * @ingroup Solvers Preconditioners
+ *
* @author Wolfgang Bangerth, 2000, 2001
*/
class SparseDirectMA47 : public Subscriptor
* from the deal.II ReadMe file. UMFPACK is included courtesy of its author,
* <a href="http://www.cise.ufl.edu/~davis/">Timothy A. Davis</a>.
*
+ *
+ * @ingroup Solvers Preconditioners
+ *
* @author Wolfgang Bangerth, 2004
*/
class SparseDirectUMFPACK : public Subscriptor
};
-/*@}*/
-
#endif