]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Remove the Software doxygen module -- it was pretty outdated, and it duplicates the...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 24 Nov 2010 15:01:47 +0000 (15:01 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 24 Nov 2010 15:01:47 +0000 (15:01 +0000)
git-svn-id: https://svn.dealii.org/trunk@22855 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/doxygen/headers/distributed.h
deal.II/doc/doxygen/headers/petsc.h
deal.II/doc/doxygen/headers/software.h [deleted file]
deal.II/doc/doxygen/headers/trilinos.h
deal.II/examples/step-31/doc/intro.dox
deal.II/include/deal.II/base/data_out_base.h
deal.II/include/deal.II/lac/petsc_vector_base.h
deal.II/include/deal.II/lac/sparse_direct.h
deal.II/include/deal.II/lac/trilinos_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h

index 2c5df2d11274ee0937e48099c85c90681c7a8446..abddb98a80a6131c60a70b829d187eb2190d4322 100644 (file)
@@ -39,8 +39,8 @@
  * 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.
index 9a83f00d5d0892ca8181c9f53c7ab9bddaceed0d..6b1aa905323609a769cbf672cb98877011eaa84e 100644 (file)
@@ -2,7 +2,7 @@
 //    $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
@@ -26,7 +26,6 @@
  * about this.
  *
  * @author Wolfgang Bangerth, 2004
- * @ref SoftwarePETSc
  *
  * @ingroup LAC
  */
diff --git a/deal.II/doc/doxygen/headers/software.h b/deal.II/doc/doxygen/headers/software.h
deleted file mode 100644 (file)
index 4782290..0000000
+++ /dev/null
@@ -1,144 +0,0 @@
-//-------------------------------------------------------------------------
-//    $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/
- */
index 558cfef8ff85904ba156c078221022c55638522d..8c4077afe0d636fbe0de482317a025b5f3cc57d1 100644 (file)
@@ -2,7 +2,7 @@
 //    $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
@@ -26,7 +26,6 @@
  * for more details about this.
  *
  * @author Martin Kronbichler, Wolfgang Bangerth, 2008
- * @ref SoftwareTrilinos
  *
  * @ingroup LAC
  */
index 792ff9cc60e10af20836ff76d15dac05b33af293..71418b6f65c28387b9236d7c2289496b902b570c 100644 (file)
@@ -948,8 +948,9 @@ multigrid have been removed.
 
 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).
index 940c56c4825173dbc2c11b46d5308737c7dd085d..30e3987af7cede3075b7230eac5b8b5ea4f88bd9 100644 (file)
@@ -205,9 +205,9 @@ class ParameterHandler;
  * <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>
  *
@@ -422,7 +422,7 @@ class DataOutBase
 
                                     /**
                                      * Flags controlling the details of
-                                     * output in @ref SoftwareOpenDX format.
+                                     * output in OpenDX format.
                                      *
                                      * @ingroup output
                                      */
@@ -503,7 +503,7 @@ class DataOutBase
                                     /**
                                      * Flags controlling the details
                                      * of output in UCD format for
-                                     * @ref SoftwareAVS.
+                                     * AVS.
                                      *
                                      * @ingroup output
                                      */
@@ -516,8 +516,8 @@ class DataOutBase
                                          * 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
@@ -636,7 +636,7 @@ class DataOutBase
 
                                     /**
                                      * Flags controlling the details
-                                     * of output in @ref SoftwarePovray
+                                     * of output in Povray
                                      * format. Several flags are
                                      * implemented, see their
                                      * respective documentation.
@@ -1048,7 +1048,7 @@ class DataOutBase
 
                                     /**
                                      * Flags controlling the details
-                                     * of output in @ref SoftwareGMV
+                                     * of output in GMV
                                      * format. At present no flags
                                      * are implemented.
                                      *
@@ -1112,8 +1112,8 @@ class DataOutBase
 
                                     /**
                                      * Flags controlling the details
-                                     * of output in @ref
-                                     * SoftwareTecplot format.
+                                     * of output in
+                                     * Tecplot format.
                                      *
                                      * @ingroup output
                                      */
@@ -1185,7 +1185,7 @@ class DataOutBase
 
                                     /**
                                      * Flags controlling the details
-                                     * of output in @ref SoftwareVTK
+                                     * of output in VTK
                                      * format. At present no flags
                                      * are implemented.
                                      *
@@ -1342,22 +1342,22 @@ class DataOutBase
                                            */
          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,
@@ -1367,19 +1367,19 @@ class DataOutBase
                                            */
          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.
@@ -1387,14 +1387,14 @@ class DataOutBase
          tecplot_binary,
 
                                           /**
-                                           * Output in @ref
-                                           * SoftwareVTK format.
+                                           * Output in
+                                           * VTK format.
                                            */
          vtk,
 
                                           /**
-                                           * Output in @ref
-                                           * SoftwareVTK format.
+                                           * Output in
+                                           * VTK format.
                                            */
          vtu,
 
@@ -1407,10 +1407,10 @@ class DataOutBase
 
 
 /**
- * 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>.
  */
@@ -1474,8 +1474,8 @@ class DataOutBase
                           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,
@@ -1558,8 +1558,8 @@ class DataOutBase
                               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
@@ -1612,8 +1612,8 @@ class DataOutBase
                              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.
@@ -1626,8 +1626,8 @@ class DataOutBase
                               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
@@ -1656,7 +1656,7 @@ class DataOutBase
 
 /**
  * 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
@@ -1677,7 +1677,7 @@ class DataOutBase
                           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.
  *
@@ -1697,7 +1697,7 @@ class DataOutBase
 
 
 /**
- * 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.
  *
@@ -2215,7 +2215,7 @@ class DataOutInterface : private DataOutBase
                                      * 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;
index 9870b3a2895f0bf7b5a802dc53c4b837438df821..1274105ef6ab2f4908ea49cffca818f858fab78b 100644 (file)
@@ -38,7 +38,6 @@ template <typename number> class Vector;
  *
  * @ingroup PETScWrappers
  * @ingroup Vectors
- * @see @ref SoftwarePETSc
  * @author Wolfgang Bangerth, 2004
  */
 namespace PETScWrappers
index 2da586716dbde07dbd7bcc754cd123b8578bc457..2f307e8fcdcad01d22eb69db71c366cf4d5f83e1 100644 (file)
@@ -2,7 +2,7 @@
 //    $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
@@ -1054,7 +1054,6 @@ class SparseDirectMA47 : public Subscriptor
  * BlockSparseMatrix<float>.
  *
  * @ingroup Solvers Preconditioners
- * @see @ref SoftwareUMFPACK
  *
  * @author Wolfgang Bangerth, 2004
  */
index 551ace6446fec0b1778b7ec35ea868027b8d4b07..ada56124048a306fedbe8e0df41d9ececf9cef26 100644 (file)
@@ -162,7 +162,6 @@ namespace TrilinosWrappers
  *
  * @ingroup TrilinosWrappers
  * @ingroup Vectors
- * @see @ref SoftwareTrilinos
  * @author Martin Kronbichler, Wolfgang Bangerth, 2008, 2009
  */
     class Vector : public VectorBase
@@ -563,7 +562,6 @@ namespace TrilinosWrappers
  *
  * @ingroup TrilinosWrappers
  * @ingroup Vectors
- * @see @ref SoftwareTrilinos
  * @author Martin Kronbichler, 2008
  */
   class Vector : public VectorBase
index 22c8d8c5c7151aca41fefd918d59ab15aa3f62f6..18394cf70c46c847b9274d98089e3144433362c0 100644 (file)
@@ -244,7 +244,6 @@ namespace TrilinosWrappers
  *
  * @ingroup TrilinosWrappers
  * @ingroup Vectors
- * @see @ref SoftwareTrilinos
  * @author Martin Kronbichler, 2008
  */
   class VectorBase : public Subscriptor

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.