Skip to content

Commit

Permalink
qf - prefer ceed/types.h over ceed.h in qf source
Browse files Browse the repository at this point in the history
  • Loading branch information
jeremylt committed Oct 17, 2024
1 parent a5f8e53 commit eff6a16
Show file tree
Hide file tree
Showing 130 changed files with 130 additions and 130 deletions.
2 changes: 1 addition & 1 deletion examples/ceed/ex1-volume.h
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
//
// This file is part of CEED: http://github.com/ceed

#include <ceed.h>
#include <ceed/types.h>

/// A structure used to pass additional data to f_build_mass
struct BuildContext {
Expand Down
2 changes: 1 addition & 1 deletion examples/ceed/ex2-surface.h
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
//
// This file is part of CEED: http://github.com/ceed

#include <ceed.h>
#include <ceed/types.h>

/// A structure used to pass additional data to f_build_diff
struct BuildContext {
Expand Down
2 changes: 1 addition & 1 deletion examples/deal.II/bps-qfunctions.h
Original file line number Diff line number Diff line change
Expand Up @@ -15,7 +15,7 @@
//
// ---------------------------------------------------------------------

#include <ceed.h>
#include <ceed/types.h>



Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/advection.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Advection initial condition and operator for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "advection_types.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/advection_types.h
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
// This file is part of CEED: http://github.com/ceed
#pragma once

#include <ceed.h>
#include <ceed/types.h>
#include "stabilization_types.h"

typedef enum {
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/blasius.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Operator for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>

#include "newtonian_state.h"
#include "newtonian_types.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/channel.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Operator for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "newtonian_state.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/densitycurrent.h
Original file line number Diff line number Diff line change
Expand Up @@ -11,7 +11,7 @@
// Model from:
// Semi-Implicit Formulations of the Navier-Stokes Equations: Application to
// Nonhydrostatic Atmospheric Modeling, Giraldo, Restelli, and Lauter (2010).
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "newtonian_state.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/differential_filter.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@
//
/// @file
/// Implementation of differential filtering
#include <ceed.h>
#include <ceed/types.h>

#include "differential_filter_enums.h"
#include "newtonian_state.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/eulervortex.h
Original file line number Diff line number Diff line change
Expand Up @@ -11,7 +11,7 @@

// Model from:
// On the Order of Accuracy and Numerical Performance of Two Classes of Finite Volume WENO Schemes, Zhang, Zhang, and Shu (2011).
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "utils.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/gaussianwave.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Thermodynamic wave propogation for testing freestream/non-reflecting boundary conditions. Proposed in Mengaldo et. al. 2014
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "newtonian_state.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/grid_anisotropy_tensor.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// Element anisotropy tensor, as defined in 'Invariant data-driven subgrid stress modeling in the strain-rate eigenframe for large eddy simulation'
/// Prakash et al. 2022
#include <ceed.h>
#include <ceed/types.h>

#include "utils.h"
#include "utils_eigensolver_jacobi.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/inverse_multiplicity.h
Original file line number Diff line number Diff line change
Expand Up @@ -4,7 +4,7 @@
// SPDX-License-Identifier: BSD-2-Clause
//
// This file is part of CEED: http://github.com/ceed
#include <ceed.h>
#include <ceed/types.h>

// @brief Calculate the inverse of the multiplicity, reducing to a single component
CEED_QFUNCTION(InverseMultiplicity)(void *ctx, CeedInt Q, const CeedScalar *const *in, CeedScalar *const *out) {
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/mass.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Mass operator for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// *****************************************************************************
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/newtonian.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Operator for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>
#include <stdlib.h>

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/newtonian_state.h
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
/// Structs and helper functions regarding the state of a newtonian simulation
#pragma once

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "newtonian_types.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/newtonian_types.h
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
// This file is part of CEED: http://github.com/ceed
#pragma once

#include <ceed.h>
#include <ceed/types.h>

#include "stabilization_types.h"

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/setupgeo.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Geometric factors (3D) for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "setupgeo_helpers.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/setupgeo2d.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Geometric factors (2D) for Navier-Stokes example using PETSc
#include <ceed.h>
#include <ceed/types.h>
#include "setupgeo_helpers.h"
#include "utils.h"

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/setupgeo_helpers.h
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
/// Geometric factors (3D) for Navier-Stokes example using PETSc
#pragma once

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "utils.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/shocktube.h
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@

// Model from:
// On the Order of Accuracy and Numerical Performance of Two Classes of Finite Volume WENO Schemes, Zhang, Zhang, and Shu (2011).
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "utils.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/stabilization.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@

/// @file
/// Helper functions for computing stabilization terms of a newtonian simulation
#include <ceed.h>
#include <ceed/types.h>

#include "newtonian_state.h"

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/stg_shur14.h
Original file line number Diff line number Diff line change
Expand Up @@ -12,7 +12,7 @@
/// SetupSTG_Rand reads in the input files and fills in STGShur14Context.
/// Then STGShur14_CalcQF is run over quadrature points.
/// Before the program exits, TearDownSTG is run to free the memory of the allocated arrays.
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>
#include <stdlib.h>

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/stg_shur14_type.h
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
// This file is part of CEED: http://github.com/ceed
#pragma once

#include <ceed.h>
#include <ceed/types.h>

#include "newtonian_types.h"

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/strong_boundary_conditions.h
Original file line number Diff line number Diff line change
Expand Up @@ -4,7 +4,7 @@
// SPDX-License-Identifier: BSD-2-Clause
//
// This file is part of CEED: http://github.com/ceed
#include <ceed.h>
#include <ceed/types.h>

#include "setupgeo_helpers.h"

Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/taylorgreen.h
Original file line number Diff line number Diff line change
Expand Up @@ -4,7 +4,7 @@
// SPDX-License-Identifier: BSD-2-Clause
//
// This file is part of CEED: http://github.com/ceed
#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "newtonian_state.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/turb_spanstats.h
Original file line number Diff line number Diff line change
Expand Up @@ -4,7 +4,7 @@
// SPDX-License-Identifier: BSD-2-Clause
//
// This file is part of CEED: http://github.com/ceed
#include <ceed.h>
#include <ceed/types.h>

#include "newtonian_state.h"
#include "turb_stats_types.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/utils.h
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
// This file is part of CEED: http://github.com/ceed
#pragma once

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#ifndef M_PI
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/utils_eigensolver_jacobi.h
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
/// Eigen system solver for symmetric NxN matrices. Modified from the CC0 code provided at https://github.com/jewettaij/jacobi_pd
#pragma once

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

#include "utils.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/fluids/qfunctions/velocity_gradient_projection.h
Original file line number Diff line number Diff line change
Expand Up @@ -4,7 +4,7 @@
// SPDX-License-Identifier: BSD-2-Clause
//
// This file is part of CEED: http://github.com/ceed
#include <ceed.h>
#include <ceed/types.h>

#include "newtonian_state.h"
#include "newtonian_types.h"
Expand Down
2 changes: 1 addition & 1 deletion examples/mfem/bp1.h
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
//
// This file is part of CEED: http://github.com/ceed

#include <ceed.h>
#include <ceed/types.h>

/// A structure used to pass additional data to f_build_mass
struct BuildContext {
Expand Down
2 changes: 1 addition & 1 deletion examples/mfem/bp3.h
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
//
// This file is part of CEED: http://github.com/ceed

#include <ceed.h>
#include <ceed/types.h>

/// A structure used to pass additional data to f_build_diff and f_apply_diff
struct BuildContext {
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/area/areacube.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example for a scalar field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/area/areasphere.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example for a scalar field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp1.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp1sphere.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example for a scalar field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp2.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp2sphere.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example for a vector field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp3.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for diffusion operator example using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp3sphere.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for diffusion operator example for a scalar field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp4.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for diffusion operator example using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/bp4sphere.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for mass operator example for a vector field on the sphere using PETSc

#include <ceed.h>
#include <ceed/types.h>
#include <math.h>

// -----------------------------------------------------------------------------
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/bps/common.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,7 @@
/// @file
/// libCEED QFunctions for BP examples using PETSc

#include <ceed.h>
#include <ceed/types.h>

// -----------------------------------------------------------------------------
CEED_QFUNCTION(Error)(void *ctx, CeedInt Q, const CeedScalar *const *in, CeedScalar *const *out) {
Expand Down
2 changes: 1 addition & 1 deletion examples/petsc/qfunctions/swarm/swarmmass.h
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
//
// This file is part of CEED: http://github.com/ceed

#include <ceed.h>
#include <ceed/types.h>

CEED_QFUNCTION(SetupMass)(void *ctx, const CeedInt Q, const CeedScalar *const *in, CeedScalar *const *out) {
const CeedScalar(*J)[3][CEED_Q_VLA] = (const CeedScalar(*)[3][CEED_Q_VLA])in[0];
Expand Down
Loading

0 comments on commit eff6a16

Please sign in to comment.