43 namespace MultiRegions
46 ExpList3DHomogeneous1D::ExpList3DHomogeneous1D():
56 const bool dealiasing):
58 lhom,useFFT,dealiasing)
68 const bool dealiasing,
70 const std::string &var,
73 lhom,useFFT,dealiasing)
86 const bool dealiasing,
90 lhom,useFFT,dealiasing)
110 for(j = 0; j < nel; ++j)
115 for(n = 1; n <
m_planes.size(); ++n)
119 for(j = 0; j < nel; ++j)
121 (*m_exp).push_back((*
m_exp)[j]);
135 if(DeclarePlanesSetCoeffPhys)
141 for(
int n = 0; n <
m_planes.size(); ++n)
157 const std::vector<unsigned int> &eIDs,
158 bool DeclarePlanesSetCoeffPhys,
162 if(DeclarePlanesSetCoeffPhys)
165 std::vector<unsigned int> eIDsPlane;
166 int nel = eIDs.size()/
m_planes.size();
168 for (
int i = 0; i < nel; ++i)
170 eIDsPlane.push_back(eIDs[i]);
174 std::dynamic_pointer_cast<ExpList> (In.
m_planes[0]);
178 (*(zero_plane_old), eIDsPlane, ImpType);
180 for(
int n = 0; n <
m_planes.size(); ++n)
200 int ncoeffs_per_plane =
m_planes[0]->GetNcoeffs();
201 int npoints_per_plane =
m_planes[0]->GetTotPoints();
212 int nel =
m_planes[0]->GetExpSize();
217 for(cnt = n = 0; n < nzplanes; ++n)
220 m_planes[n]->SetPhysArray(tmparray =
m_phys + npoints_per_plane*n);
222 for(i = 0; i < nel; ++i)
240 (*m_exp)[eid]->GetCoords(xc0,xc1);
246 for(n = 0; n <
m_planes.size(); n++)
256 for(n = 0; n < nzplanes; ++n)
258 Vmath::Fill(npoints,z[n],tmp_xc = xc2 + npoints*n,1);
290 int npoints =
m_planes[0]->GetTotPoints();
299 for(n = 0; n <
m_planes.size(); n++)
309 for(n = 0; n < nzplanes; ++n)
311 Vmath::Fill(npoints,z[n],tmp_xc = xc2 + npoints*n,1);
322 ASSERTL0(expansion == -1,
"Multi-zone output not supported for homogeneous expansions.");
324 const int nPtsPlane =
m_planes[0]->GetNpoints();
325 const int nElmt =
m_planes[0]->GetExpSize();
326 const int nPlanes =
m_planes.size();
330 for (
int i = 0; i < nElmt; ++i)
332 const int np0 = (*m_exp)[i]->GetNumPoints(0);
333 const int np1 = (*m_exp)[i]->GetNumPoints(1);
335 for (
int n = 1; n < nPlanes; ++n)
337 const int o1 = (n-1) * nPtsPlane;
338 const int o2 = n * nPtsPlane;
339 for (
int j = 1; j < np1; ++j)
341 for(
int k = 1; k < np0; ++k)
343 outfile << cnt + (j-1)*np0 + (k-1) + o1 + 1 <<
" ";
344 outfile << cnt + (j-1)*np0 + (k-1) + o2 + 1 <<
" ";
345 outfile << cnt + (j-1)*np0 + k + o2 + 1 <<
" ";
346 outfile << cnt + (j-1)*np0 + k + o1 + 1 <<
" ";
347 outfile << cnt + j *np0 + (k-1) + o1 + 1 <<
" ";
348 outfile << cnt + j *np0 + (k-1) + o2 + 1 <<
" ";
349 outfile << cnt + j *np0 + k + o2 + 1 <<
" ";
350 outfile << cnt + j *np0 + k + o1 + 1 << endl;
362 std::ostream &outfile,
369 m_planes[0]->WriteVtkPieceHeader(outfile, expansion);
374 int outputExtraPlane = 0;
379 outputExtraPlane = 1;
383 int nq0 = (*m_exp)[expansion]->GetNumPoints(0);
384 int nq1 = (*m_exp)[expansion]->GetNumPoints(1);
385 int nq2 =
m_planes.size() + outputExtraPlane;
386 int ntot = nq0*nq1*nq2;
387 int ntotminus = (nq0-1)*(nq1-1)*(nq2-1);
393 GetCoords(expansion,coords[0],coords[1],coords[2]);
395 if (outputExtraPlane)
400 tmp = coords[0] + (nq2-1)*nq0*nq1, 1);
402 tmp = coords[1] + (nq2-1)*nq0*nq1, 1);
405 (coords[2][nq0*nq1] - coords[2][0]);
406 Vmath::Fill(nq0*nq1, z, tmp = coords[2] + (nq2-1)*nq0*nq1, 1);
410 m_session->LoadParameter(
"DistStrip", DistStrip, 0);
412 for(
int i = 0; i < ntot; i++)
414 coords[2][i] += istrip*DistStrip;
417 outfile <<
" <Piece NumberOfPoints=\""
418 << ntot <<
"\" NumberOfCells=\""
419 << ntotminus <<
"\">" << endl;
420 outfile <<
" <Points>" << endl;
421 outfile <<
" <DataArray type=\"Float64\" "
422 <<
"NumberOfComponents=\"3\" format=\"ascii\">" << endl;
424 for (i = 0; i < ntot; ++i)
426 for (j = 0; j < 3; ++j)
428 outfile << coords[j][i] <<
" ";
433 outfile <<
" </DataArray>" << endl;
434 outfile <<
" </Points>" << endl;
435 outfile <<
" <Cells>" << endl;
436 outfile <<
" <DataArray type=\"Int32\" "
437 <<
"Name=\"connectivity\" format=\"ascii\">" << endl;
438 for (i = 0; i < nq0-1; ++i)
440 for (j = 0; j < nq1-1; ++j)
442 for (k = 0; k < nq2-1; ++k)
444 outfile << k*nq0*nq1 + j*nq0 + i <<
" "
445 << k*nq0*nq1 + j*nq0 + i + 1 <<
" "
446 << k*nq0*nq1 + (j+1)*nq0 + i + 1 <<
" "
447 << k*nq0*nq1 + (j+1)*nq0 + i <<
" "
448 << (k+1)*nq0*nq1 + j*nq0 + i <<
" "
449 << (k+1)*nq0*nq1 + j*nq0 + i + 1 <<
" "
450 << (k+1)*nq0*nq1 + (j+1)*nq0 + i + 1 <<
" "
451 << (k+1)*nq0*nq1 + (j+1)*nq0 + i << endl;
456 outfile <<
" </DataArray>" << endl;
457 outfile <<
" <DataArray type=\"Int32\" "
458 <<
"Name=\"offsets\" format=\"ascii\">" << endl;
459 for (i = 0; i < ntotminus; ++i)
461 outfile << i*8+8 <<
" ";
464 outfile <<
" </DataArray>" << endl;
465 outfile <<
" <DataArray type=\"UInt8\" "
466 <<
"Name=\"types\" format=\"ascii\">" << endl;
467 for (i = 0; i < ntotminus; ++i)
472 outfile <<
" </DataArray>" << endl;
473 outfile <<
" </Cells>" << endl;
474 outfile <<
" <PointData>" << endl;
486 for(
int n = 0; n <
m_planes.size(); n++)
493 for(
int n = 0; n <
m_planes.size(); ++n)
495 errL2 =
m_planes[n]->L2(inarray + cnt);
497 err += errL2*errL2*local_w[n]*
m_lhom*0.5;
502 for(
int n = 0; n <
m_planes.size(); ++n)
504 errL2 =
m_planes[n]->L2(inarray + cnt, soln + cnt);
506 err += errL2*errL2*local_w[n]*
m_lhom*0.5;
520 for (
int n = 0; n <
m_planes[0]->GetExpSize(); ++n)
523 area +=
m_planes[0]->GetExp(n)->Integral(inarray);
529 for (
int n = 0; n <
m_planes.size(); n += 2)
535 for(
int i = 0; i <
m_planes[n]->GetExpSize(); ++i)
542 energy[n/2] += err*err;
548 energy[n/2] += err*err;
552 energy[n/2] /= 2.0*area;
#define ASSERTL0(condition, msg)
Describes the specification for a Basis.
static std::shared_ptr< DataType > AllocateSharedPtr(const Args &...args)
Allocate a shared pointer from the memory pool.
Abstraction of a two-dimensional multi-elemental expansion which is merely a collection of local expa...
void GenExpList3DHomogeneous1D(const SpatialDomains::ExpansionInfoMap &expansions, const Collections::ImplementationType ImpType)
virtual ~ExpList3DHomogeneous1D()
Destructor.
virtual void v_GetCoords(Array< OneD, NekDouble > &coord_0, Array< OneD, NekDouble > &coord_1, Array< OneD, NekDouble > &coord_2)
virtual void v_WriteVtkPieceHeader(std::ostream &outfile, int expansion, int istrip)
void SetCoeffPhys(void)
Definition of the total number of degrees of freedom and quadrature points. Sets up the storage for m...
virtual NekDouble v_L2(const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &soln=NullNekDouble1DArray)
virtual Array< OneD, const NekDouble > v_HomogeneousEnergy(void)
virtual void v_WriteTecplotConnectivity(std::ostream &outfile, int expansion)
ExpList3DHomogeneous1D()
Default constructor.
void GetCoords(Array< OneD, NekDouble > &coord_0, Array< OneD, NekDouble > &coord_1=NullNekDouble1DArray, Array< OneD, NekDouble > &coord_2=NullNekDouble1DArray)
This function calculates the coordinates of all the elemental quadrature points .
Abstraction of a two-dimensional multi-elemental expansion which is merely a collection of local expa...
NekDouble m_lhom
Width of homogeneous direction.
LibUtilities::TranspositionSharedPtr m_transposition
Array< OneD, ExpListSharedPtr > m_planes
LibUtilities::BasisSharedPtr m_homogeneousBasis
Definition of the total number of degrees of freedom and quadrature points. Sets up the storage for m...
Array< OneD, NekDouble > m_coeffs
Concatenation of all local expansion coefficients.
const Array< OneD, const NekDouble > & GetCoeffs() const
This function returns (a reference to) the array (implemented as m_coeffs) containing all local expa...
int GetCoeff_Offset(int n) const
Get the start offset position for a global list of m_coeffs correspoinding to element n.
Array< OneD, int > m_coeff_offset
Offset of elemental data into the array m_coeffs.
LibUtilities::CommSharedPtr m_comm
Communicator.
std::shared_ptr< LocalRegions::ExpansionVector > m_exp
The list of local expansions.
int m_ncoeffs
The total number of local degrees of freedom. m_ncoeffs .
const std::shared_ptr< LocalRegions::ExpansionVector > GetExp() const
This function returns the vector of elements in the expansion.
SpatialDomains::MeshGraphSharedPtr m_graph
Mesh associated with this expansion list.
LibUtilities::SessionReaderSharedPtr m_session
Session.
Array< OneD, int > m_phys_offset
Offset of elemental data into the array m_phys.
ExpansionType m_expType
Exapnsion type.
Array< OneD, NekDouble > m_phys
The global expansion evaluated at the quadrature points.
int GetTotPoints(void) const
Returns the total number of quadrature points m_npoints .
std::shared_ptr< SessionReader > SessionReaderSharedPtr
@ eFourierEvenlySpaced
1D Evenly-spaced points using Fourier Fit
@ eFourier
Fourier Expansion .
std::shared_ptr< Expansion > ExpansionSharedPtr
std::shared_ptr< ExpList > ExpListSharedPtr
Shared pointer to an ExpList object.
std::shared_ptr< MeshGraph > MeshGraphSharedPtr
std::map< int, ExpansionInfoShPtr > ExpansionInfoMap
The above copyright notice and this permission notice shall be included.
static Array< OneD, NekDouble > NullNekDouble1DArray
void Smul(int n, const T alpha, const T *x, const int incx, T *y, const int incy)
Scalar multiply y = alpha*x.
void Fill(int n, const T alpha, T *x, const int incx)
Fill a vector with a constant value.
void Sadd(int n, const T alpha, const T *x, const int incx, T *y, const int incy)
Add vector y = alpha - x.
void Vcopy(int n, const T *x, const int incx, T *y, const int incy)
scalarT< T > sqrt(scalarT< T > in)