* because most of the things one wants to do in a finite element
* program still work in essentially the same way, and handling
* distributed matrices, vectors, and linear solvers is something for
- * which good external libraries such as @ref SoftwareTrilinos or @ref
- * SoftwarePETSc exist that can make things look almost exactly the
+ * which good external libraries such as Trilinos or
+ * PETSc exist that can make things look almost exactly the
* same as they would if everything was available locally. The use of
* this mode of parallelization is explained in the tutorial programs
* step-17, and step-18 and will not be discussed here in more detail.
// $Id$
// Version: $Name$
//
-// Copyright (C) 2003, 2004, 2006 by the deal.II authors
+// Copyright (C) 2003, 2004, 2006, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* about this.
*
* @author Wolfgang Bangerth, 2004
- * @ref SoftwarePETSc
*
* @ingroup LAC
*/
+++ /dev/null
-//-------------------------------------------------------------------------
-// $Id$
-// Version: $Name$
-//
-// Copyright (C) 2005, 2006, 2007, 2008, 2009 by the deal.II authors
-//
-// This file is subject to QPL and may not be distributed
-// without copyright and license information. Please refer
-// to the file deal.II/doc/license.html for the text and
-// further information on this license.
-//
-//-------------------------------------------------------------------------
-
-/**
- * @page DEALSoftware Third party software deal.II interfaces with
- *
- * @note Names of software products are trademarks of their respective owners.
- *
- * This is a list of software packages that deal.II interacts with in some
- * way, either by supporting a data format of another program, or by actively
- * calling functions of other packages. Configuration of interfaces, if
- * necessary at all, is described in the deal.II ReadMe file.
- *
- *
- * @section SodtwarePrePost Pre- and Postprocessing
- *
- * @subsection SoftwareVis Visualization tools
- *
- * This is a list of visualization formats and software that deal.II
- * supports. Data in these formats is written by the DataOutBase and in parts
- * by the GridOut classes (see @ref output).
- *
- *
- * @subsubsection SoftwareAVS AVS Express
- *
- * deal.II reads and writes the UCD format specified in the AVS
- * Express user manual. See http://www.avs.com/ for more details on
- * this software.
- *
- * @subsubsection SoftwareGMV GMV
- *
- * Output for the General Mesh Viewer can be produced. See
- * http://www-xdiv.lanl.gov/XCM/gmv/GMVHome.html for details on GMV
- *
- * @subsubsection SoftwareGnuplot gnuplot
- *
- * Two-dimensional data can be written in a format suitable for
- * gnuplot, even on locally refined and unstructured meshes, See
- * http://www.gnuplot.info/
- *
- *
- * @subsubsection SoftwareOpenDX OpenDX
- *
- * The former IBM Visual Data Explorer, now an OpenSource project at
- * http://www.opendx.org/.
- *
- *
- * @subsubsection SoftwarePovray Povray
- *
- * While it is not actually taylored to scientific visualization, you
- * may be able to produce impressive pictures of three-dimensional
- * deformed bodies with http://www.povray.org/
- *
- *
- * @subsubsection SoftwareTecplot Tecplot
- *
- * deal.II writes textual and binary files for Tecplot. See
- * http://www.tecplot.com for more details on this software.
- *
- *
- * @subsubsection SoftwareXFig XFig
- *
- * Though not a visualization tool at all, you can nevertheless write grids in
- * XFig format 3.2. Those can be postprocessed manually within XFig and
- * written in many different graphics formats. See http://www.xfig.org/
- *
- *
- * @subsubsection SoftwareVTK VTK
- *
- * The Visualisation Toolkit VTK is an open format supported by a
- * number of visualization projects such as ParaView, VisIt, or
- * MayaVi. See http://public.kitware.com/VTK/ . The file format is described
- * at http://vtk.org/pdf/file-formats.pdf .
- *
- *
- *
- * @section SoftwareLibs Libraries used inside deal.II
- *
- * @subsection SoftwarePETSc PETSc
- *
- * PETSc is a library that supports, among other things, a large number of
- * linear algebra data structures and algorithms, in much the same way as we
- * do in the linear algebra classes of deal.II (see @ref LAC). However, PETSc
- * goes beyond what we have to offer in that it has more algorithms (for
- * example algebraic multigrid) and most importantly it works in parallel on
- * distributed memory clusters, using MPI.
- *
- * In order to support parallel computations in deal.II, we have
- * written interfaces to many PETSc functions and data structures in
- * the PETScWrapper namespace, that allow the use of PETSc in much the
- * same way as deal.II's own linear algebra classes are used. The use
- * of these wrappers is explained in the step-17 and step-18 example
- * programs, as well as in the @ref PETScWrappers module. The <a
- * href="../../readme-petsc-trilinos.html">PETSc and Trilinos
- * ReadMe</a> file explains how to configure deal.II to use PETSc.
- *
- * PETSc can be obtained from http://www.mcs.anl.gov/petsc/.
- *
- *
- * @subsection SoftwareTrilinos Trilinos
- *
- * Trilinos, like @ref SoftwarePETSc, is a library that supports, among other
- * things of interest to numerical computations, a large number of linear
- * algebra data structures and algorithms. It, too, can work on parallel
- * clusters.
- *
- * Interfaces to Trilinos exist in the TrilinosWrappers namespace,
- * making matrices, vectors, and solvers look like the corresponding
- * deal.II classes. Their use is explained in the @ref step_31
- * "step-31", step-32, and step-33
- * tutorial programs. The <a
- * href="../../readme-petsc-trilinos.html">PETSc and Trilinos
- * ReadMe</a> file explains how to configure deal.II to use this
- * feature.
- *
- * Trilinos can be obtained from http://trilinos.sandia.gov.
- *
- *
- * @subsection SoftwareMETIS METIS
- *
- * METIS is a tool that allows to partition a graph into chunks of roughly
- * equal size. We use it to subdivide a domain into blocks that have about the
- * same number of cells, when distributing work for parallel programs. METIS
- * can be obtained from http://www-users.cs.umn.edu/~karypis/metis/index.html
- *
- *
- * @subsection SoftwareUMFPACK UMFPACK
- *
- * UMFPACK is a sparse direct solver and is included by permission with
- * deal.II distributions. To configure its available, read the README file.
- *
- * UMFPACK can be obtained from
- * http://www.cise.ufl.edu/research/sparse/umfpack/
- */
// $Id$
// Version: $Name$
//
-// Copyright (C) 2008 by the deal.II authors
+// Copyright (C) 2008, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* for more details about this.
*
* @author Martin Kronbichler, Wolfgang Bangerth, 2008
- * @ref SoftwareTrilinos
*
* @ingroup LAC
*/
In much the same way as we used PETSc to support our linear algebra needs in
step-17 and step-18, we use interfaces to the <a
-href="http://trilinos.sandia.gov">Trilinos</a> library (see @ref
-SoftwareTrilinos) in this program. Trilinos is a very large collection of
+href="http://trilinos.sandia.gov">Trilinos</a> library (see the
+deal.II README file for installation instructions) in this program. Trilinos
+is a very large collection of
everything that has to do with linear and nonlinear algebra, as well as all
sorts of tools around that (and looks like it will grow in many other
directions in the future as well).
* <li>EPS output based on an earlier implementation by Stefan Nauber
* for the old DataOut class
*
- * <li>@ref SoftwarePovray output by Thomas Richter
+ * <li>Povray output by Thomas Richter
*
- * <li>@ref SoftwareTecplot output by Benjamin Shelton Kirk
+ * <li>Tecplot output by Benjamin Shelton Kirk
*
* </ul>
*
/**
* Flags controlling the details of
- * output in @ref SoftwareOpenDX format.
+ * output in OpenDX format.
*
* @ingroup output
*/
/**
* Flags controlling the details
* of output in UCD format for
- * @ref SoftwareAVS.
+ * AVS.
*
* @ingroup output
*/
* creation and some other
* data. While this is
* supported by the UCD
- * format and @ref
- * SoftwareAVS, some other
+ * format and
+ * AVS, some other
* programs get confused by
* this, so the default is to
* not write a
/**
* Flags controlling the details
- * of output in @ref SoftwarePovray
+ * of output in Povray
* format. Several flags are
* implemented, see their
* respective documentation.
/**
* Flags controlling the details
- * of output in @ref SoftwareGMV
+ * of output in GMV
* format. At present no flags
* are implemented.
*
/**
* Flags controlling the details
- * of output in @ref
- * SoftwareTecplot format.
+ * of output in
+ * Tecplot format.
*
* @ingroup output
*/
/**
* Flags controlling the details
- * of output in @ref SoftwareVTK
+ * of output in VTK
* format. At present no flags
* are implemented.
*
*/
none,
/**
- * Output for @ref SoftwareOpenDX.
+ * Output for OpenDX.
*/
dx,
/**
* Output in the UCD format
- * for @ref SoftwareAVS.
+ * for AVS.
*/
ucd,
/**
- * Output for the @ref
- * SoftwareGnuplot tool.
+ * Output for the
+ * Gnuplot tool.
*/
gnuplot,
/**
- * Output for the @ref
- * SoftwarePovray
+ * Output for the
+ * Povray
* raytracer.
*/
povray,
*/
eps,
/**
- * Output for @ref SoftwareGMV.
+ * Output for GMV.
*/
gmv,
/**
- * Output for @ref
- * SoftwareTecplot in text
+ * Output for
+ * Tecplot in text
* format.
*/
tecplot,
/**
- * Output for @ref
- * SoftwareTecplot in
+ * Output for
+ * Tecplot in
* binary format. Faster
* and smaller than text
* format.
tecplot_binary,
/**
- * Output in @ref
- * SoftwareVTK format.
+ * Output in
+ * VTK format.
*/
vtk,
/**
- * Output in @ref
- * SoftwareVTK format.
+ * Output in
+ * VTK format.
*/
vtu,
/**
- * Write the given list of patches to the output stream in @ref
- * SoftwareOpenDX format.
+ * Write the given list of patches to the output stream in
+ * OpenDX format.
*
- * Since @ref SoftwareOpenDX uses some kind of visual data flow oriented
+ * Since OpenDX uses some kind of visual data flow oriented
* programming language, some of these programs are provided in
* <tt>contrib/dx</tt>.
*/
std::ostream &out);
/**
- * Write the given list of patches to the output stream in @ref
- * SoftwareGMV format.
+ * Write the given list of patches to the output stream in
+ * GMV format.
*
* Data is written in the following format: nodes are considered the
* points of the patches. In spatial dimensions less than three,
std::ostream &out);
/**
- * Write the given list of patches to the output stream for the @ref
- * SoftwarePovray raytracer.
+ * Write the given list of patches to the output stream for the
+ * Povray raytracer.
*
* Output in this format creates a povray source file, include
* standard camera and light source definition for rendering with
std::ostream &out);
/**
- * Write the given list of patches to the output stream in @ref
- * SoftwareTecplot ASCII format (FEBLOCK).
+ * Write the given list of patches to the output stream in
+ * Tecplot ASCII format (FEBLOCK).
*
* For more information consult the Tecplot Users and Reference
* manuals.
std::ostream &out);
/**
- * Write the given list of patches to the output stream in @ref
- * SoftwareTecplot binary format.
+ * Write the given list of patches to the output stream in
+ * Tecplot binary format.
*
* For this to work properly <tt>./configure</tt> checks for the
* Tecplot API at build time. To write Tecplot binary files directly
/**
* Write the given list of patches to the output stream in UCD format
- * described in the AVS developer's guide (now @ref SoftwareAVS). Due
+ * described in the AVS developer's guide (now AVS). Due
* to limitations in the present format, only node based data can be
* output, which in one reason why we invented the patch concept. In
* order to write higher order elements, you may split them up into
std::ostream &out);
/**
- * Write the given list of patches to the output stream in @ref SoftwareVTK
+ * Write the given list of patches to the output stream in VTK
* format. The data is written in the traditional VTK format as opposed to the
* XML-based format that write_vtu() produces.
*
/**
- * Write the given list of patches to the output stream in @ref SoftwareVTK
+ * Write the given list of patches to the output stream in VTK
* format. The data is written in the XML-based VTK format as opposed to the
* traditional format that write_vtk() produces.
*
* Obtain data through
* get_patches() and write it to
* <tt>out</tt> in UCD format for
- * @ref SoftwareAVS. See
+ * AVS. See
* DataOutBase::write_ucd.
*/
void write_ucd (std::ostream &out) const;
*
* @ingroup PETScWrappers
* @ingroup Vectors
- * @see @ref SoftwarePETSc
* @author Wolfgang Bangerth, 2004
*/
namespace PETScWrappers
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* BlockSparseMatrix<float>.
*
* @ingroup Solvers Preconditioners
- * @see @ref SoftwareUMFPACK
*
* @author Wolfgang Bangerth, 2004
*/
*
* @ingroup TrilinosWrappers
* @ingroup Vectors
- * @see @ref SoftwareTrilinos
* @author Martin Kronbichler, Wolfgang Bangerth, 2008, 2009
*/
class Vector : public VectorBase
*
* @ingroup TrilinosWrappers
* @ingroup Vectors
- * @see @ref SoftwareTrilinos
* @author Martin Kronbichler, 2008
*/
class Vector : public VectorBase
*
* @ingroup TrilinosWrappers
* @ingroup Vectors
- * @see @ref SoftwareTrilinos
* @author Martin Kronbichler, 2008
*/
class VectorBase : public Subscriptor