From: Wolfgang Bangerth <bangerth@colostate.edu>
Date: Tue, 5 May 2020 21:28:13 +0000 (-0600)
Subject: Move a reference to references.bib.
X-Git-Tag: v9.2.0-rc1~122^2
X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e492c06e79950076f9184925dd49908de497bc2c;p=dealii.git

Move a reference to references.bib.
---

diff --git a/doc/doxygen/references.bib b/doc/doxygen/references.bib
index 2073a9fb2d..1a07590727 100644
--- a/doc/doxygen/references.bib
+++ b/doc/doxygen/references.bib
@@ -658,6 +658,17 @@ year = {2008},
 % References used elsewhere
 % ------------------------------------
 
+@article{KGZB83,
+  author  = {Kelly, D. W. and {De S. R. Gago}, J. P. and Zienkiewicz, O. C.
+             and Babu\v{s}ka, I.},
+  title   = {A posteriori error analysis and adaptive processes in the
+             finite element method: Part {I}--Error Analysis},
+  journal = {Int. J. Num. Meth. Engrg.},
+  year    = {1983},
+  volume  = {19},
+  pages   = {1593--1619}
+}
+
 @article{park2003p,
    title     = {P1-nonconforming quadrilateral finite element methods for
                 second-order elliptic problems},
diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h
index cbe774b2e7..a5d9bc0291 100644
--- a/include/deal.II/numerics/error_estimator.h
+++ b/include/deal.II/numerics/error_estimator.h
@@ -47,9 +47,9 @@ namespace hp
 
 /**
  * Implementation of the error indicator by Kelly, De S. R. Gago, Zienkiewicz
- * and Babuska and its modification for the hp-FEM. This error indicator tries
- * to approximate the error per cell by integration of the jump of the
- * gradient of the solution along the faces of each cell.  It can be
+ * and Babuska (see @cite KGZB83) and its modification for the hp-FEM. This
+ * error indicator tries to approximate the error per cell by integration of the
+ * jump of the gradient of the solution along the faces of each cell.  It can be
  * understood as a gradient recovery estimator; see the survey of Ainsworth
  * and Oden, "A Posteriori Error Estimation in Finite Element Analysis"
  * (Wiley, 2000) for a complete discussion.
@@ -79,21 +79,6 @@ namespace hp
  * This vector contains elements of data type @p float, rather than @p double,
  * since accuracy is not important in the current context.
  *
- * The full reference for the paper in which this error estimator is defined
- * is as follows:
- * @code{.bib}
- * @article{KGZB83,
- *   author  = {Kelly, D. W. and {De S. R. Gago}, J. P. and Zienkiewicz, O. C.
- *              and Babu\v{s}ka, I.},
- *   title   = {A posteriori error analysis and adaptive processes in the
- *              finite element method: Part {I}--Error Analysis},
- *   journal = {Int. J. Num. Meth. Engrg.},
- *   year    = {1983},
- *   volume  = {19},
- *   pages   = {1593--1619}
- * }
- * @endcode
- *
  *
  * <h3>Implementation</h3>
  *