From: David Wells <wellsd2@rpi.edu>
Date: Thu, 12 Jan 2017 15:01:58 +0000 (-0500)
Subject: Fix doxygen formatting of URLs with hyphens.
X-Git-Tag: v8.5.0-rc1~258^2~1
X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=83e6b04844f522f3053cd127f48a2ae3f5c9f78b;p=dealii.git

Fix doxygen formatting of URLs with hyphens.

The script wrapcomments.py was previously allowed to split lines after hyphens
which results in broken links.
---

diff --git a/contrib/utilities/wrapcomments.py b/contrib/utilities/wrapcomments.py
index 63f5a83946..fe8e37650d 100755
--- a/contrib/utilities/wrapcomments.py
+++ b/contrib/utilities/wrapcomments.py
@@ -27,7 +27,12 @@
 from __future__ import print_function
 import textwrap
 import sys, re
-wrapper = textwrap.TextWrapper()
+
+# As of python 2.6 we can tell the text wrapper to not break on hyphens. This is
+# usually what we want to do: we don't want to split URLs with hyphens and
+# doxygen will format 'non-primitive' as 'non- primitive' if it is
+# (inadvertantly) split across two lines.
+wrapper = textwrap.TextWrapper(break_on_hyphens=False)
 
 # take an array of lines and wrap them to 78 columns and let each line start
 # with @p startwith
diff --git a/include/deal.II/base/polynomials_bernstein.h b/include/deal.II/base/polynomials_bernstein.h
index a4feed04f4..befc6c0b4d 100644
--- a/include/deal.II/base/polynomials_bernstein.h
+++ b/include/deal.II/base/polynomials_bernstein.h
@@ -26,9 +26,9 @@ DEAL_II_NAMESPACE_OPEN
 
 /**
  * This class implements Bernstein basis polynomials of desire degree as
- * described in http://www.idav.ucdavis.edu/education/CAGDNotes/Bernstein-
- * Polynomials.pdf in the paragraph "Converting from the Bernstein Basis to
- * the Power Basis".
+ * described in
+ * http://www.idav.ucdavis.edu/education/CAGDNotes/Bernstein-Polynomials.pdf in
+ * the paragraph "Converting from the Bernstein Basis to the Power Basis".
  *
  * They are used to create the Bernstein finite element FE_Bernstein.
  *
diff --git a/include/deal.II/grid/grid_in.h b/include/deal.II/grid/grid_in.h
index cc39692d72..da171c89bb 100644
--- a/include/deal.II/grid/grid_in.h
+++ b/include/deal.II/grid/grid_in.h
@@ -155,15 +155,15 @@ template <int dim> struct CellData;
  * generator, see http://www.salome-platform.org/ . The sections of the format
  * that the GridIn::read_unv function supports are documented here:
  * <ul>
- * <li> section 2411: http://www.sdrl.uc.edu/universal-file-formats-for-modal-
- * analysis-testing-1/file-format-storehouse/unv_2411.htm
- * <li> section 2412: http://www.sdrl.uc.edu/universal-file-formats-for-modal-
- * analysis-testing-1/file-format-storehouse/unv_2412.htm
- * <li> section 2467: http://www.sdrl.uc.edu/universal-file-formats-for-modal-
- * analysis-testing-1/file-format-storehouse/unv_2467.htm
+ * <li> section 2411:
+ * http://www.sdrl.uc.edu/universal-file-formats-for-modal-analysis-testing-1/file-format-storehouse/unv_2411.htm
+ * <li> section 2412:
+ * http://www.sdrl.uc.edu/universal-file-formats-for-modal-analysis-testing-1/file-format-storehouse/unv_2412.htm
+ * <li> section 2467:
+ * http://www.sdrl.uc.edu/universal-file-formats-for-modal-analysis-testing-1/file-format-storehouse/unv_2467.htm
  * <li> all sections of this format, even if they may not be supported in our
- * reader, can be found here: http://www.sdrl.uc.edu/universal-file-formats-
- * for-modal-analysis-testing-1/file-format-storehouse/file-formats
+ * reader, can be found here:
+ * http://www.sdrl.uc.edu/universal-file-formats-for-modal-analysis-testing-1/file-format-storehouse/file-formats
  * </ul>
  * Note that Salome, let's say in 2D, can only make a quad mesh on an object
  * that has exactly 4 edges (or 4 pieces of the boundary). That means, that if
diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h
index e92012bd4e..4f8bfadfb6 100644
--- a/include/deal.II/lac/petsc_matrix_base.h
+++ b/include/deal.II/lac/petsc_matrix_base.h
@@ -852,8 +852,7 @@ namespace PETScWrappers
      * Print the PETSc matrix object values using PETSc internal matrix viewer
      * function <tt>MatView</tt>. The default format prints the non- zero
      * matrix elements. For other valid view formats, consult
-     * http://www.mcs.anl.gov/petsc/petsc-
-     * current/docs/manualpages/Mat/MatView.html
+     * http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatView.html
      */
     void write_ascii (const PetscViewerFormat format = PETSC_VIEWER_DEFAULT);
 
diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h
index 3ae0852178..f08b6f450e 100644
--- a/include/deal.II/lac/petsc_solver.h
+++ b/include/deal.II/lac/petsc_solver.h
@@ -922,8 +922,7 @@ namespace PETScWrappers
    *
    * @note The class internally calls KSPSetFromOptions thus you are able to
    * use all the PETSc parameters for MATSOLVERMUMPS package. See
-   * http://www.mcs.anl.gov/petsc/petsc-
-   * current/docs/manualpages/Mat/MATSOLVERMUMPS.html
+   * http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MATSOLVERMUMPS.html
    *
    * @ingroup PETScWrappers
    * @author Daniel Brauss, Alexander Grayver, 2012
diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h
index c33204eac2..9db20fd08e 100644
--- a/include/deal.II/lac/petsc_vector_base.h
+++ b/include/deal.II/lac/petsc_vector_base.h
@@ -700,8 +700,8 @@ namespace PETScWrappers
      * Prints the PETSc vector object values using PETSc internal vector
      * viewer function <tt>VecView</tt>. The default format prints the
      * vector's contents, including indices of vector elements. For other
-     * valid view formats, consult http://www.mcs.anl.gov/petsc/petsc-
-     * current/docs/manualpages/Vec/VecView.html
+     * valid view formats, consult
+     * http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/VecView.html
      */
     void write_ascii (const PetscViewerFormat format = PETSC_VIEWER_DEFAULT) ;
 
diff --git a/include/deal.II/lac/slepc_spectral_transformation.h b/include/deal.II/lac/slepc_spectral_transformation.h
index 530fe029e8..a49270d890 100644
--- a/include/deal.II/lac/slepc_spectral_transformation.h
+++ b/include/deal.II/lac/slepc_spectral_transformation.h
@@ -86,8 +86,8 @@ namespace SLEPcWrappers
      * the spectral transformations.
      *
      * The possible values are given by the enumerator STMatMode in the SLEPc
-     * library http://www.grycap.upv.es/slepc/documentation/current/docs/manua
-     * lpages/ST/STMatMode.html
+     * library
+     * http://www.grycap.upv.es/slepc/documentation/current/docs/manualpages/ST/STMatMode.html
      */
     void set_matrix_mode(const STMatMode mode);