From d1b462f99752861a6b1fda92f13750195a6e0869 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Thu, 30 Mar 2000 13:40:36 +0000 Subject: [PATCH] Still remove many of those bogus indentations! git-svn-id: https://svn.dealii.org/trunk@2650 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/dofs/dof_handler.h | 8 ++++---- deal.II/deal.II/include/fe/fe.h | 4 ++-- deal.II/deal.II/include/fe/fe_system.h | 12 ++++++++---- deal.II/deal.II/include/fe/fe_values.h | 6 +++--- deal.II/deal.II/include/fe/q1_mapping.h | 2 +- deal.II/deal.II/include/grid/grid_out.h | 10 +++++----- deal.II/deal.II/include/grid/tria.h | 12 ++++++------ deal.II/deal.II/include/grid/tria_levels.h | 4 ++-- .../deal.II/include/numerics/data_out_stack.h | 4 ++-- .../deal.II/include/numerics/dof_renumbering.h | 2 +- deal.II/deal.II/include/numerics/histogram.h | 2 +- .../deal.II/include/numerics/time_dependent.h | 16 ++++++++-------- deal.II/deal.II/include/numerics/vectors.h | 2 +- deal.II/lac/include/lac/vector.h | 10 +++++----- 14 files changed, 49 insertions(+), 45 deletions(-) diff --git a/deal.II/deal.II/include/dofs/dof_handler.h b/deal.II/deal.II/include/dofs/dof_handler.h index 67cc4a3b17..1631309634 100644 --- a/deal.II/deal.II/include/dofs/dof_handler.h +++ b/deal.II/deal.II/include/dofs/dof_handler.h @@ -720,7 +720,7 @@ class DoFHandler : public Subscriptor, //@} -/*---------------------------------------*/ + /*---------------------------------------*/ /** * @name Line iterator functions @@ -779,7 +779,7 @@ class DoFHandler : public Subscriptor, active_line_iterator end_active_line (const unsigned int level) const; -/** + /** * Return an iterator pointing to the * last line, used or not. */ @@ -876,7 +876,7 @@ class DoFHandler : public Subscriptor, active_quad_iterator end_active_quad (const unsigned int level) const; -/** + /** * Return an iterator pointing to the * last quad, used or not. */ @@ -1023,7 +1023,7 @@ class DoFHandler : public Subscriptor, /*---------------------------------------*/ -/** + /** * Return number of degrees of freedom. * Included in this number are those * DoFs which are constrained by diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index 81dbc4c91f..da23ce0be4 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -106,7 +106,7 @@ class FiniteElementData const unsigned int transform_functions; -/** + /** * Number of components and dimension of * the image space. */ @@ -199,7 +199,7 @@ class FiniteElementData unsigned int n_transform_functions () const; -/** + /** * Comparison operator. It is not clear to * me (WB) why we have to declare and implement * this one explicitely. diff --git a/deal.II/deal.II/include/fe/fe_system.h b/deal.II/deal.II/include/fe/fe_system.h index b1089cd5da..eb792f8c50 100644 --- a/deal.II/deal.II/include/fe/fe_system.h +++ b/deal.II/deal.II/include/fe/fe_system.h @@ -345,7 +345,9 @@ class FESystem : public FiniteElement vector > &normal_vectors) const; /** - * Implementation of the corresponding function of #FiniteElement#. + * Implementation of the + * corresponding function of + * #FiniteElement#. */ virtual void fill_fe_values (const DoFHandler::cell_iterator &cell, const vector > &unit_points, @@ -399,7 +401,8 @@ class FESystem : public FiniteElement private: /** - * Pairs of multiplicity and element type. + * Pairs of multiplicity and + * element type. */ typedef pair *, unsigned int> ElementPair; @@ -417,7 +420,7 @@ class FESystem : public FiniteElement vector< ElementPair > base_elements; -/** + /** * Helper function used in the constructor: * take a #FiniteElementData# object * and return an object of the same type @@ -455,7 +458,7 @@ class FESystem : public FiniteElement const unsigned int N3); -/** + /** * Helper function used in the constructor: * takes a #FiniteElement# object * and returns an boolean vector including @@ -466,6 +469,7 @@ class FESystem : public FiniteElement static vector compute_restriction_is_additive_flags (const FiniteElement &fe, const unsigned int N); + /** * Same as above for mixed elements * with two different sub-elements. diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index be937cadba..736522b5bd 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -259,7 +259,7 @@ class FEValuesBase const FiniteElement &fe); -/** + /** * Return the value of the #i#th shape * function at the #j# quadrature point * on the cell, face or subface selected @@ -738,7 +738,7 @@ class FEValues : public FEValuesBase public: -/** + /** * Constructor. Fill all arrays with the * values of the shape functions of the * specified finite element using the @@ -883,7 +883,7 @@ class FEValues : public FEValuesBase * available without complicated matrix-vector-multiplications. * * @author Wolfgang Bangerth, 1998 -*/ + */ template class FEFaceValuesBase : public FEValuesBase { diff --git a/deal.II/deal.II/include/fe/q1_mapping.h b/deal.II/deal.II/include/fe/q1_mapping.h index e5a20522a0..298edb09b4 100644 --- a/deal.II/deal.II/include/fe/q1_mapping.h +++ b/deal.II/deal.II/include/fe/q1_mapping.h @@ -177,7 +177,7 @@ class FEQ1Mapping : public FiniteElement vector > &jacobians); -/** + /** * Exception */ DeclException0 (ExcInternalError); diff --git a/deal.II/deal.II/include/grid/grid_out.h b/deal.II/deal.II/include/grid/grid_out.h index a64027718c..40986ceba0 100644 --- a/deal.II/deal.II/include/grid/grid_out.h +++ b/deal.II/deal.II/include/grid/grid_out.h @@ -213,7 +213,7 @@ class GridOut }; -/** + /** * Flags describing the details of * output in GNUPLOT format. */ @@ -313,7 +313,7 @@ class GridOut }; -/** + /** * Flags describing the details of * output for encapsulated postscript * for all dimensions not explicitely @@ -371,7 +371,7 @@ class GridOut //#endif -/** + /** * Declaration of a name for each of the * different output formats. */ @@ -498,7 +498,7 @@ class GridOut static string get_output_format_names (); -/** + /** * Exception */ DeclException0 (ExcInvalidState); @@ -548,7 +548,7 @@ class GridOut EpsFlags<3> eps_flags_3; -/** + /** * Write the grid information about * faces to #out#. Only those faces * are printed which are on the boundary diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index 7076cc8765..90e769c8e4 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -1781,7 +1781,7 @@ class Triangulation : public TriaDimensionInfo, const bool keep_boundary=true); -/** + /** * @name Mesh refinement */ /*@{*/ @@ -2042,7 +2042,7 @@ class Triangulation : public TriaDimensionInfo, /*@}*/ -/** + /** * @name User flag handling */ /*@{*/ @@ -2226,7 +2226,7 @@ class Triangulation : public TriaDimensionInfo, active_cell_iterator end_active (const unsigned int level) const; -/** + /** * Return an iterator pointing to the * last cell, used or not. * @@ -2408,7 +2408,7 @@ class Triangulation : public TriaDimensionInfo, /*@}*/ -/*---------------------------------------*/ + /*---------------------------------------*/ /** * @name Line iterator functions @@ -2888,7 +2888,7 @@ class Triangulation : public TriaDimensionInfo, /*@}*/ -/** + /** * @name Exceptions */ /*@{*/ @@ -3115,7 +3115,7 @@ class Triangulation : public TriaDimensionInfo, void update_number_cache_hexes (); -/** + /** * Array of pointers pointing to the * #TriangulationLevel# objects * storing the data on the different diff --git a/deal.II/deal.II/include/grid/tria_levels.h b/deal.II/deal.II/include/grid/tria_levels.h index b7444a186c..9f0897749a 100644 --- a/deal.II/deal.II/include/grid/tria_levels.h +++ b/deal.II/deal.II/include/grid/tria_levels.h @@ -393,7 +393,7 @@ class TriangulationLevel<2> : public TriangulationLevel<1> vector material_id; -/** + /** * Pointer which is not used by the * library but may be accessed an set * by the user to handle data local to @@ -499,7 +499,7 @@ class TriangulationLevel<3> : public TriangulationLevel<2> vector material_id; -/** + /** * Pointer which is not used by the * library but may be accessed an set * by the user to handle data local to diff --git a/deal.II/deal.II/include/numerics/data_out_stack.h b/deal.II/deal.II/include/numerics/data_out_stack.h index af0bfbb5c5..0289205e75 100644 --- a/deal.II/deal.II/include/numerics/data_out_stack.h +++ b/deal.II/deal.II/include/numerics/data_out_stack.h @@ -178,7 +178,7 @@ class DataOutStack : public DataOutInterface const VectorType vector_type); -/** + /** * Add a data vector for the presently * set value of the parameter. * @@ -391,7 +391,7 @@ class DataOutStack : public DataOutInterface virtual const vector > & get_patches () const; -/** + /** * Virtual function through * which the names of data sets are * obtained by the output functions diff --git a/deal.II/deal.II/include/numerics/dof_renumbering.h b/deal.II/deal.II/include/numerics/dof_renumbering.h index af0809ae95..6cfc780663 100644 --- a/deal.II/deal.II/include/numerics/dof_renumbering.h +++ b/deal.II/deal.II/include/numerics/dof_renumbering.h @@ -246,7 +246,7 @@ class DoFRenumbering const vector &component_order = vector()); -/** + /** * Exception */ DeclException0 (ExcRenumberingIncomplete); diff --git a/deal.II/deal.II/include/numerics/histogram.h b/deal.II/deal.II/include/numerics/histogram.h index e0c78a5dff..922c04b59f 100644 --- a/deal.II/deal.II/include/numerics/histogram.h +++ b/deal.II/deal.II/include/numerics/histogram.h @@ -72,7 +72,7 @@ class Histogram }; -/** + /** * Take several lists of values, each on * to produce one histogram that will * then be arrange one behind each other. diff --git a/deal.II/deal.II/include/numerics/time_dependent.h b/deal.II/deal.II/include/numerics/time_dependent.h index 25a4f39334..764edcfdf8 100644 --- a/deal.II/deal.II/include/numerics/time_dependent.h +++ b/deal.II/deal.II/include/numerics/time_dependent.h @@ -434,7 +434,7 @@ class TimeDependent const TimeSteppingData &data_postprocess); -/** + /** * Destructor. This will delete the * objects pointed to by the pointers * given to the #insert_*# and @@ -604,7 +604,7 @@ class TimeDependent const Direction direction); -/** + /** * Initialize the objects for the next * sweep. This function specifically does * the following: assign each time @@ -1075,7 +1075,7 @@ class TimeStepBase : public Subscriptor void set_sweep_no (const unsigned int sweep_no); -/** + /** * Copy constructor. I can see no reason * why someone might want to use it, so * I don't provide it. Since this class @@ -1138,7 +1138,7 @@ class TimeStepBase_Tria : public TimeStepBase }; -/** + /** * Default constructor. Does nothing but * throws an exception. We need to have * such a constructor in order to satisfy @@ -1633,7 +1633,7 @@ struct TimeStepBase_Tria::RefinementFlags const unsigned int first_sweep_with_correction; -/** + /** * Apply cell number correction with the * previous time level only if there are * more than this number of cells. @@ -1788,7 +1788,7 @@ void TimeDependent::do_loop (InitFunctionObject init_function, }; -// wake up the first few time levels + // wake up the first few time levels for (int step=-timestepping_data.look_ahead; step<0; ++step) for (int look_ahead=0; look_ahead<=static_cast(timestepping_data.look_ahead); ++look_ahead) @@ -1805,7 +1805,7 @@ void TimeDependent::do_loop (InitFunctionObject init_function, }; -for (unsigned int step=0; step &p_select); -/** + /** * Exception */ DeclException0 (ExcNotUseful); diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index b5017424a1..6e39eaa79d 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -49,7 +49,7 @@ class Vector { typedef size_t size_type; -/** + /** * @name 1: Basic Object-handling */ //@{ @@ -159,7 +159,7 @@ class Vector { Number linfty_norm () const; -/** + /** * Change the dimension of the vector to * #N#. The reserved memory for this vector * remains unchanged if possible, to make @@ -239,7 +239,7 @@ class Vector { //@} -/** + /** * @name 2: Data-Access */ //@{ @@ -256,7 +256,7 @@ class Vector { //@} -/** + /** * @name 3: Modification of vectors */ //@{ @@ -364,7 +364,7 @@ class Vector { //@} -/** + /** * @name 5: Mixed stuff */ //@{ -- 2.39.5