]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix doxygen formatting of URLs with hyphens.
authorDavid Wells <wellsd2@rpi.edu>
Thu, 12 Jan 2017 15:01:58 +0000 (10:01 -0500)
committerDavid Wells <wellsd2@rpi.edu>
Thu, 12 Jan 2017 15:09:53 +0000 (10:09 -0500)
The script wrapcomments.py was previously allowed to split lines after hyphens
which results in broken links.

contrib/utilities/wrapcomments.py
include/deal.II/base/polynomials_bernstein.h
include/deal.II/grid/grid_in.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/slepc_spectral_transformation.h

index 63f5a8394600046a755d331c11c736f335063435..fe8e37650d68b3c7b43c4c917b5632983a2a1c79 100755 (executable)
 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
index a4feed04f4653b480b7c40a2da3da0addab95678..befc6c0b4d08cd822668e419577a882dfea010bf 100644 (file)
@@ -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.
  *
index cc39692d72a2ff202b09455565ce790576932cd3..da171c89bb2e5f558b4acd3ca6bf039ce6edab58 100644 (file)
@@ -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
index e92012bd4e29c4d569d9d538cfe52e132ab7ff4c..4f8bfadfb6dda19c94cc3fc61ccbb260871475e1 100644 (file)
@@ -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);
 
index 3ae08521784b6288e907ac355c5b765cf536c47e..f08b6f450e0e94039fc2f92a8d55f74e18378b4d 100644 (file)
@@ -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
index c33204eac2f9d952e069ea174925e2f0effb0818..9db20fd08e0fcafea87227217c06cf1afe19552c 100644 (file)
@@ -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) ;
 
index 530fe029e8db6f52416bb6a2f4c8a967d94e6f43..a49270d8901416b63f67fa0dfaab05f1aa614536 100644 (file)
@@ -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);
 

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.