]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
add group and fix sign in StokesLSingularity
authorkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 20 Jun 2007 17:07:07 +0000 (17:07 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 20 Jun 2007 17:07:07 +0000 (17:07 +0000)
git-svn-id: https://svn.dealii.org/trunk@14791 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/base/include/base/flow_function.h
deal.II/base/source/flow_function.cc

index c22c8204e3e320152eb2f71994e4f86bea7ebcee..29ae0e34f4954a6e1954fa131d6db35a7564532d 100644 (file)
@@ -38,6 +38,7 @@ namespace Functions
  * values. Therefore, every thread should obtain its own object of
  * derived classes.
  *
+ * @ingroup functions
  * @author Guido Kanschat, 2007
  */
   template <int dim>
@@ -135,6 +136,7 @@ namespace Functions
  * #Reynolds number is used to scale the pressure properly for a
  * Navier-Stokes problem.
  *
+ * @ingroup functions
  * @author Guido Kanschat, 2007
  */
   template <int dim>
@@ -168,6 +170,7 @@ namespace Functions
  *
  * Taken from Houston, Sch&ouml;tzau, Wihler, proceeding ENUMATH 2003.
  *
+ * @ingroup functions
  * @author Guido Kanschat, 2007
  */
   class StokesLSingularity : public FlowFunction<2>
index 57805c40c480bd5ebef8194bc1b064a7233fa9da..4287941d2cd074d075ef2dfc72758f5048333038 100644 (file)
@@ -289,7 +289,7 @@ namespace Functions
            values[0][k] = std::pow(r2,lambda/2.)
                           * ((1.+lambda) * std::sin(phi) * Psi(phi)
                              + std::cos(phi) * Psi_1(phi));
-           values[1][k] = std::pow(r2,lambda/2.)
+           values[1][k] = -std::pow(r2,lambda/2.)
                           * (std::sin(phi) * Psi_1(phi)
                              -(1.+lambda) * std::cos(phi) * Psi(phi));
            values[2][k] = -std::pow(r2,lambda/2.-.5)

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.