61 :
Geometry2D(edges[0]->GetVertex(0)->GetCoordim(), curve)
86 m_coordim = edges[0]->GetVertex(0)->GetCoordim();
99 for (
int i = 0; i <
kNedges; i++)
115 int i0 = 1, i1 = 0, direction = 1;
116 for (
size_t i = 0; i <
m_verts.size(); ++i)
131 for (
size_t i = 0; i <
m_verts.size(); ++i)
148 for (
size_t i = 0; i <
m_verts.size(); ++i)
160 for (
size_t i = 0; i <
m_verts.size(); ++i)
162 int i1 = (i + 1) %
m_verts.size();
169 m_verts[i1]->GetCoords(vertex);
193 int order0 = std::max(
m_edges[0]->
GetXmap()->GetBasis(0)->GetNumModes(),
195 int order1 = std::max(
m_edges[1]->
GetXmap()->GetBasis(0)->GetNumModes(),
198 std::array<LibUtilities::BasisKey, 2> basis = {
219 return m_xmap->PhysEvaluate(Lcoord, tmp);
237 std::array<PointGeom *, 4> face1, std::array<PointGeom *, 4> face2,
240 int i, j, vmap[4] = {-1, -1, -1, -1};
246 for (i = 0; i < 4; ++i)
248 rotPt.
Rotate((*face1[i]), dir, angle);
249 for (j = 0; j < 4; ++j)
251 if (rotPt.
dist(*face2[j]) < tol)
262 NekDouble x, y, z, x1, y1, z1, cx = 0.0, cy = 0.0, cz = 0.0;
268 for (i = 0; i < 4; ++i)
270 cx += (*face2[i])(0) - (*face1[i])(0);
271 cy += (*face2[i])(1) - (*face1[i])(1);
272 cz += (*face2[i])(2) - (*face1[i])(2);
281 for (i = 0; i < 4; ++i)
286 for (j = 0; j < 4; ++j)
288 x1 = (*face2[j])(0) - cx;
289 y1 = (*face2[j])(1) - cy;
290 z1 = (*face2[j])(2) - cz;
291 if (
sqrt((x1 - x) * (x1 - x) + (y1 - y) * (y1 - y) +
292 (z1 - z) * (z1 - z)) < 1e-8)
303 if (vmap[1] == (vmap[0] + 1) % 4)
340 ASSERTL0(
false,
"unable to determine face orientation");
368 if ((
m_xmap->GetBasisNumModes(0) != 2) ||
369 (
m_xmap->GetBasisNumModes(1) != 2))
407 double tmp = std::fabs(norm[0]);
408 if (tmp < fabs(norm[1]))
413 if (tmp < fabs(norm[2]))
425 for (
int i = 0; i <
m_verts.size(); ++i)
428 m_verts[i]->GetCoords(verts[i]);
433 for (
int i = 0; i < 2; i++)
486 int npts =
m_curve->m_points.size();
495 ASSERTL0(nEdgePts * nEdgePts == npts,
496 "NUMPOINTS should be a square number in"
503 "Number of edge points does not correspond to "
504 "number of face points in quadrilateral " +
510 for (j = 0; j < npts; ++j)
512 tmp[j] = (
m_curve->m_points[j]->GetPtr())[i];
517 m_xmap->GetBasis(0)->GetPointsKey(),
518 m_xmap->GetBasis(1)->GetPointsKey(),
535 nEdgeCoeffs =
m_edges[i]->GetXmap()->GetNcoeffs();
539 for (k = 0; k < nEdgeCoeffs; k++)
542 signArray[k] * (
m_edges[i]->GetCoeffs(j))[k];
566 std::vector<NekDouble> c(3);
567 for (
int i = 0; i < 3; ++i)
571 if (fabs(c[1]) >= fabs(c[2]))
608 CurveMap::iterator it = curvedFaces.find(
m_globalID);
610 if (it != curvedFaces.end())
615 for (
int i = 0; i < 4; ++i)
617 m_edges[i]->Reset(curvedEdges, curvedFaces);
628 for (
int i = 0; i < 4; ++i)
#define ASSERTL0(condition, msg)
#define ASSERTL1(condition, msg)
Assert Level 1 – Debugging which is used whether in FULLDEBUG or DEBUG compilation mode....
Describes the specification for a Basis.
Defines a specification for a set of points.
static std::shared_ptr< DataType > AllocateSharedPtr(const Args &...args)
Allocate a shared pointer from the memory pool.
Array< OneD, int > m_manifold
Array< OneD, Array< OneD, NekDouble > > m_edgeNormal
void v_CalculateInverseIsoParam() override
bool m_setupState
Wether or not the setup routines have been run.
GeomState m_state
Enumeration to dictate whether coefficients are filled.
void SetUpCoeffs(const int nCoeffs)
Initialise the Geometry::m_coeffs array.
Array< OneD, Array< OneD, NekDouble > > m_isoParameter
virtual void v_Reset(CurveMap &curvedEdges, CurveMap &curvedFaces)
Reset this geometry object: unset the current state, zero Geometry::m_coeffs and remove allocated Geo...
int GetGlobalID(void) const
Get the ID of this object.
LibUtilities::ShapeType m_shapeType
Type of shape.
Array< OneD, Array< OneD, NekDouble > > m_coeffs
Array containing expansion coefficients of m_xmap.
GeomState m_geomFactorsState
State of the geometric factors.
StdRegions::StdExpansionSharedPtr m_xmap
mapping containing isoparametric transformation.
StdRegions::StdExpansionSharedPtr GetXmap() const
Return the mapping object Geometry::m_xmap that represents the coordinate transformation from standar...
GeomFactorsSharedPtr m_geomFactors
Geometric factors.
int m_coordim
Coordinate dimension of this geometry object.
void Sub(PointGeom &a, PointGeom &b)
void Mult(PointGeom &a, PointGeom &b)
_this = a x b
void Rotate(PointGeom &a, int dir, NekDouble angle)
_this = rotation of a by angle 'angle' around axis dir
NekDouble dist(PointGeom &a)
return distance between this and input a
std::array< PointGeom *, kNverts > m_verts
void v_Reset(CurveMap &curvedEdges, CurveMap &curvedFaces) override
Reset this geometry object: unset the current state, zero Geometry::m_coeffs and remove allocated Geo...
static StdRegions::Orientation GetFaceOrientation(const QuadGeom &face1, const QuadGeom &face2, bool doRot=false, int dir=0, NekDouble angle=0.0, NekDouble tol=1e-8)
Get the orientation of face1.
std::array< StdRegions::Orientation, kNedges > m_eorient
NekDouble v_GetCoord(const int i, const Array< OneD, const NekDouble > &Lcoord) override
Given local collapsed coordinate Lcoord, return the value of physical coordinate in direction i.
void PreSolveStraightEdge()
void v_GenGeomFactors() override
std::array< SegGeom *, kNedges > m_edges
void v_FillGeom() override
int v_GetDir(const int faceidx, const int facedir) const override
Returns the element coordinate direction corresponding to a given face coordinate direction.
int v_AllLeftCheck(const Array< OneD, const NekDouble > &gloCoord) override
static StdRegions::Orientation GetEdgeOrientation(const SegGeom &edge1, const SegGeom &edge2)
Get the orientation of edge1.
A simple factory for Xmap objects that is based on the element type, the basis and quadrature selecti...
void Interp2D(const BasisKey &fbasis0, const BasisKey &fbasis1, const Array< OneD, const NekDouble > &from, const BasisKey &tbasis0, const BasisKey &tbasis1, Array< OneD, NekDouble > &to)
this function interpolates a 2D function evaluated at the quadrature points of the 2D basis,...
@ beta
Gauss Radau pinned at x=-1,.
@ eGaussLobattoLegendre
1D Gauss-Lobatto-Legendre quadrature points
@ eModified_A
Principle Modified Functions .
static const NekDouble kNekZeroTol
std::shared_ptr< Curve > CurveSharedPtr
std::unordered_map< int, CurveSharedPtr > CurveMap
GeomType
Indicates the type of element geometry.
@ eRegular
Geometry is straight-sided with constant geometric factors.
@ eDeformed
Geometry is curved or has non-constant factors.
XmapFactory< StdRegions::StdQuadExp, 2 > & GetStdQuadFactory()
@ ePtsFilled
Geometric information has been generated.
@ eDir1BwdDir2_Dir2BwdDir1
@ eDir1FwdDir1_Dir2FwdDir2
@ eDir1BwdDir1_Dir2BwdDir2
@ eDir1BwdDir2_Dir2FwdDir1
@ eDir1FwdDir1_Dir2BwdDir2
@ eDir1BwdDir1_Dir2FwdDir2
@ eDir1FwdDir2_Dir2FwdDir1
@ eDir1FwdDir2_Dir2BwdDir1
void Vcopy(int n, const T *x, const int incx, T *y, const int incy)
scalarT< T > sqrt(scalarT< T > in)