Skip to content

Commit

Permalink
issue [#36]
Browse files Browse the repository at this point in the history
  • Loading branch information
bgranzow committed Apr 17, 2017
1 parent ef455cc commit d4e93f6
Show file tree
Hide file tree
Showing 67 changed files with 67 additions and 67 deletions.
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_residual.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -56,4 +56,4 @@ void Residual<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class Residual<goal::Traits::Residual, goal::Traits>;
template class Residual<goal::Traits::Jacobian, goal::Traits>;

} // namespace elast
} /* namespace elast */
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_residual.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -83,6 +83,6 @@ class Residual : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem, Node, Dim> resid;
};

} // namespace elast
} /* namespace elast */

#endif
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_stress.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -82,4 +82,4 @@ void Stress<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class Stress<goal::Traits::Residual, goal::Traits>;
template class Stress<goal::Traits::Jacobian, goal::Traits>;

} // namespace elast
} /* namespace elast */
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_stress.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -98,6 +98,6 @@ class Stress : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem, IP, Dim, Dim> cauchy;
};

} // namespace goal
} /* namespace elast */

#endif
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_traction_bcs.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -118,4 +118,4 @@ void TractionBCs<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class TractionBCs<goal::Traits::Residual, goal::Traits>;
template class TractionBCs<goal::Traits::Jacobian, goal::Traits>;

} // namespace elast
} /* namespace elast */
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_traction_bcs.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -86,6 +86,6 @@ class TractionBCs : public PHX::EvaluatorWithBaseImpl<TRAITS>,
int num_dims;
};

} // namespace elast
} /* namespace elast */

#endif
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_von_mises.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -56,4 +56,4 @@ void VonMises<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class VonMises<goal::Traits::Residual, goal::Traits>;
template class VonMises<goal::Traits::Jacobian, goal::Traits>;

} // namespace elast
} /* namespace elast */
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_ev_von_mises.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,6 +76,6 @@ class VonMises : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem, IP> von_mises;
};

} // namespace elast
} /* namespace elast */

#endif
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_physics.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -128,7 +128,7 @@ void Physics::build_error_dirichlet(FieldManager fm) {
(void)fm;
}

} // namespace elast
} /* namespace elast */

#include <goal_ev_utils.hpp>
#include <goal_ev_dirichlet_bcs.hpp>
Expand Down
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_physics.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -104,6 +104,6 @@ class Physics : public goal::Physics {
int p_order;
};

} // namespace elast
} /* namespace elast */

#endif
2 changes: 1 addition & 1 deletion miniapps/elasticity/elast_solver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -135,7 +135,7 @@ void Solver::solve() {
else solve_primal_only();
}

} // namespace elast
} /* namespace elast */

int main(int argc, char** argv) {
goal::initialize();
Expand Down
2 changes: 1 addition & 1 deletion miniapps/poisson/poisson_ev_residual.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,4 +76,4 @@ void Residual<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class Residual<goal::Traits::Residual, goal::Traits>;
template class Residual<goal::Traits::Jacobian, goal::Traits>;

} // namespace poisson
} /* namespace poisson */
2 changes: 1 addition & 1 deletion miniapps/poisson/poisson_ev_residual.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -93,6 +93,6 @@ class Residual : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem, Node> resid;
};

} // namespace poisson
} /* namespace poisson */

#endif
2 changes: 1 addition & 1 deletion miniapps/poisson/poisson_physics.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -95,4 +95,4 @@ void Physics::build_error_volumetric(FieldManager fm) {
(void)fm;
}

} // namespace poisson
} /* namespace poisson */
2 changes: 1 addition & 1 deletion miniapps/poisson/poisson_physics.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -90,6 +90,6 @@ class Physics : public goal::Physics {
std::string set;
};

} // namespace poisson
} /* namespace poisson */

#endif
2 changes: 1 addition & 1 deletion miniapps/poisson/poisson_solver.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -128,7 +128,7 @@ void Solver::solve() {
output->write(0);
}

} // namespace poisson
} /* namespace poisson */


int main(int argc, char** argv) {
Expand Down
2 changes: 1 addition & 1 deletion src/goal_assembly.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -144,4 +144,4 @@ template void assemble_dirichlet<goal::Traits::Residual>(
template void assemble_dirichlet<goal::Traits::Jacobian>(
Workset& ws, RCP<Physics> p, RCP<SolutionInfo> i, RCP<Discretization> d);

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_assembly.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,4 +76,4 @@ void compute_dual_jacobian(RCP<Physics> p, RCP<SolutionInfo> i,
void compute_error_residual(RCP<Physics> p, RCP<SolutionInfo> i,
RCP<Discretization> d, const double t_current, const double t_previous);

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_control.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,4 +76,4 @@ double eval(std::string const& v, double x, double y, double z, double t) {

double time() { return PCU_Time(); }

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_control.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -35,6 +35,6 @@ double eval(std::string const& v, double x, double y, double z, double t);
/** \brief Get the wall time in seconds. */
double time();

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_data_types.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -58,6 +58,6 @@ typedef Tpetra::CrsMatrix<ST, LO, GO, KNode> Matrix;
/** \brief Tpetra matrix output class type. */
typedef Tpetra::MatrixMarket::Writer<Matrix> MM_Writer;

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_dimension.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -8,4 +8,4 @@ PHX_DIM_TAG_IMPLEMENTATION(Dim)
PHX_DIM_TAG_IMPLEMENTATION(IP)
PHX_DIM_TAG_IMPLEMENTATION(Dummy)

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_dimension.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -13,6 +13,6 @@ PHX_DIM_TAG_DECLARATION(Dim)
PHX_DIM_TAG_DECLARATION(IP)
PHX_DIM_TAG_DECLARATION(Dummy)

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_discretization.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -249,4 +249,4 @@ void Discretization::compute_side_sets() {
mesh->end(it);
}

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_discretization.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -138,6 +138,6 @@ class Discretization {
std::map<std::string, std::vector<apf::MeshEntity*> > side_sets;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_dirichlet_bcs.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -288,4 +288,4 @@ void DirichletBCs<goal::Traits::Jacobian, TRAITS>::evaluateFields(
template class DirichletBCs<goal::Traits::Residual, goal::Traits>;
template class DirichletBCs<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_dirichlet_bcs.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -128,6 +128,6 @@ class DirichletBCs<goal::Traits::Jacobian, TRAITS>
void apply_dual_bc();
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_gather_scalar.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -85,4 +85,4 @@ void GatherScalar<goal::Traits::Jacobian, TRAITS>::evaluateFields(
template class GatherScalar<goal::Traits::Residual, goal::Traits>;
template class GatherScalar<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_gather_scalar.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -109,6 +109,6 @@ class GatherScalar<goal::Traits::Jacobian, TRAITS>
PHX::MDField<ScalarT, Elem, Node> u;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_gather_vector.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -91,4 +91,4 @@ void GatherVector<goal::Traits::Jacobian, TRAITS>::evaluateFields(
template class GatherVector<goal::Traits::Residual, goal::Traits>;
template class GatherVector<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_gather_vector.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -111,6 +111,6 @@ class GatherVector<goal::Traits::Jacobian, TRAITS>
PHX::MDField<ScalarT, Elem, Node, Dim> u;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_interpolate_scalar.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -59,4 +59,4 @@ void InterpolateScalar<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class InterpolateScalar<goal::Traits::Residual, goal::Traits>;
template class InterpolateScalar<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_interpolate_vector.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -62,4 +62,4 @@ void InterpolateVector<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class InterpolateVector<goal::Traits::Residual, goal::Traits>;
template class InterpolateVector<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_interpolate_vector.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -81,6 +81,6 @@ class InterpolateVector : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem, IP, Dim, Dim> grad_u;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_ks.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -59,4 +59,4 @@ void QoIKS<EVALT, TRAITS>::postEvaluate(PostEvalData info) {

template class QoIKS<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_ks.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -89,6 +89,6 @@ class QoIKS : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem> J;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_pnorm.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -59,4 +59,4 @@ void QoIPNorm<EVALT, TRAITS>::postEvaluate(PostEvalData info) {

template class QoIPNorm<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_pnorm.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -73,6 +73,6 @@ class QoIPNorm : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem> J;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_scalar_point.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -67,4 +67,4 @@ void QoIScalarPoint<EVALT, TRAITS>::postEvaluate(PostEvalData info) {

template class QoIScalarPoint<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_qoi_scalar_point.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -87,6 +87,6 @@ class QoIScalarPoint : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<ScalarT, Elem> pw_u;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_scalar_shape.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -67,4 +67,4 @@ void ScalarShape<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class ScalarShape<goal::Traits::Residual, goal::Traits>;
template class ScalarShape<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_scalar_shape.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,6 +76,6 @@ class ScalarShape : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<double, Elem, Node, IP, Dim> grad_shape;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_functional.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -58,4 +58,4 @@ void ScatterFunctional<goal::Traits::Jacobian, TRAITS>::evaluateFields(

template class ScatterFunctional<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_functional.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,6 +76,6 @@ class ScatterFunctional<goal::Traits::Jacobian, TRAITS>
PHX::MDField<const ScalarT, Elem> functional;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_scalar.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -138,4 +138,4 @@ void ScatterScalar<goal::Traits::Jacobian, TRAITS>::evaluateFields(
template class ScatterScalar<goal::Traits::Residual, goal::Traits>;
template class ScatterScalar<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_scalar.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -138,6 +138,6 @@ class ScatterScalar<goal::Traits::Jacobian, TRAITS>
PHX::MDField<const ScalarT, Elem, Node> resid;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_vector.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -148,4 +148,4 @@ void ScatterVector<goal::Traits::Jacobian, TRAITS>::evaluateFields(
template class ScatterVector<goal::Traits::Residual, goal::Traits>;
template class ScatterVector<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_scatter_vector.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -135,6 +135,6 @@ class ScatterVector<goal::Traits::Jacobian, TRAITS>
PHX::MDField<const ScalarT, Elem, Node, Dim> resid;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_utils.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -151,4 +151,4 @@ template void require_adjoint_scatter<goal::Traits::Jacobian>(RCP<Field> u, RCP<
template void require_dbc<goal::Traits::Residual>(RCP<const ParameterList> p, RCP<Indexer> i, bool condense, bool adj, FieldManager fm);
template void require_dbc<goal::Traits::Jacobian>(RCP<const ParameterList> p, RCP<Indexer> i, bool condense, bool adj, FieldManager fm);

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_utils.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -91,6 +91,6 @@ void require_qoi(RCP<const ParameterList> p, RCP<Field> u, RCP<Indexer> i,
void require_qoi_scalar_point(RCP<Field> u, RCP<Indexer> i,
std::string const& set, FieldManager fm);

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_ev_vector_shape.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -69,4 +69,4 @@ void VectorShape<EVALT, TRAITS>::evaluateFields(EvalData workset) {
template class VectorShape<goal::Traits::Residual, goal::Traits>;
template class VectorShape<goal::Traits::Jacobian, goal::Traits>;

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_ev_vector_shape.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -76,6 +76,6 @@ class VectorShape : public PHX::EvaluatorWithBaseImpl<TRAITS>,
PHX::MDField<double, Elem, Node, IP, Dim, Dim> grad_shape;
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_field.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -268,4 +268,4 @@ void project_field(RCP<Field> to, RCP<Field> from) {
fail("project: unknown value type");
}

} // namespace goal
} /* namespace goal */
2 changes: 1 addition & 1 deletion src/goal_field.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -280,6 +280,6 @@ class Field {
/** \brief Project data from one field to another. */
void project_field(RCP<Field> to, RCP<Field> from);

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_field_types.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -23,6 +23,6 @@ enum BasisType {
HIERARCHIC = 1
};

} // namespace goal
} /* namespace goal */

#endif
2 changes: 1 addition & 1 deletion src/goal_indexer.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -245,4 +245,4 @@ void Indexer::compute_node_sets() {
}
}

} // namespace goal
} /* namespace goal */
Loading

0 comments on commit d4e93f6

Please sign in to comment.