//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void AssembleScalarElemOpenSolverAlgorithm::execute() { stk::mesh::BulkData & bulk_data = realm_.bulk_data(); stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); const double small = 1.0e-16; // extract user advection options (allow to potentially change over time) const std::string dofName = scalarQ_->name(); const double alphaUpw = realm_.get_alpha_upw_factor(dofName); const double hoUpwind = realm_.get_upw_factor(dofName); // one minus flavor.. const double om_alphaUpw = 1.0-alphaUpw; // space for LHS/RHS; nodesPerElement*nodesPerElement and nodesPerElement std::vector<double> lhs; std::vector<double> rhs; std::vector<int> scratchIds; std::vector<double> scratchVals; std::vector<stk::mesh::Entity> connected_nodes; // ip values; only boundary std::vector<double> coordBip(nDim); // pointers to fixed values double *p_coordBip = &coordBip[0]; // nodal fields to gather std::vector<double> ws_face_coordinates; std::vector<double> ws_scalarQNp1; std::vector<double> ws_bcScalarQ; // master element std::vector<double> ws_face_shape_function; // deal with state ScalarFieldType &scalarQNp1 = scalarQ_->field_of_state(stk::mesh::StateNP1); ScalarFieldType &densityNp1 = density_->field_of_state(stk::mesh::StateNP1); // define vector of parent topos; should always be UNITY in size std::vector<stk::topology> parentTopo; // define some common selectors stk::mesh::Selector s_locally_owned_union = meta_data.locally_owned_part() &stk::mesh::selectUnion(partVec_); stk::mesh::BucketVector const& face_buckets = realm_.get_buckets( meta_data.side_rank(), s_locally_owned_union ); for ( stk::mesh::BucketVector::const_iterator ib = face_buckets.begin(); ib != face_buckets.end() ; ++ib ) { stk::mesh::Bucket & b = **ib ; // extract connected element topology b.parent_topology(stk::topology::ELEMENT_RANK, parentTopo); ThrowAssert ( parentTopo.size() == 1 ); stk::topology theElemTopo = parentTopo[0]; // volume master element MasterElement *meSCS = realm_.get_surface_master_element(theElemTopo); const int nodesPerElement = meSCS->nodesPerElement_; // face master element MasterElement *meFC = realm_.get_surface_master_element(b.topology()); const int nodesPerFace = meFC->nodesPerElement_; const int numScsBip = meFC->numIntPoints_; std::vector<int> face_node_ordinal_vec(nodesPerFace); // resize some things; matrix related const int lhsSize = nodesPerElement*nodesPerElement; const int rhsSize = nodesPerElement; lhs.resize(lhsSize); rhs.resize(rhsSize); scratchIds.resize(rhsSize); scratchVals.resize(rhsSize); connected_nodes.resize(nodesPerElement); // algorithm related; element ws_face_coordinates.resize(nodesPerFace*nDim); ws_scalarQNp1.resize(nodesPerFace); ws_bcScalarQ.resize(nodesPerFace); ws_face_shape_function.resize(numScsBip*nodesPerFace); // pointers double *p_lhs = &lhs[0]; double *p_rhs = &rhs[0]; double *p_face_coordinates = &ws_face_coordinates[0]; double *p_scalarQNp1 = &ws_scalarQNp1[0]; double *p_bcScalarQ = &ws_bcScalarQ[0]; double *p_face_shape_function = &ws_face_shape_function[0]; // shape functions meFC->shape_fcn(&p_face_shape_function[0]); const stk::mesh::Bucket::size_type length = b.size(); for ( stk::mesh::Bucket::size_type k = 0 ; k < length ; ++k ) { // zero lhs/rhs for ( int p = 0; p < lhsSize; ++p ) p_lhs[p] = 0.0; for ( int p = 0; p < rhsSize; ++p ) p_rhs[p] = 0.0; // get face stk::mesh::Entity face = b[k]; // pointer to face data const double * mdot = stk::mesh::field_data(*openMassFlowRate_, face); //====================================== // gather nodal data off of face //====================================== stk::mesh::Entity const * face_node_rels = bulk_data.begin_nodes(face); int num_face_nodes = bulk_data.num_nodes(face); // sanity check on num nodes ThrowAssert( num_face_nodes == nodesPerFace ); for ( int ni = 0; ni < num_face_nodes; ++ni ) { stk::mesh::Entity node = face_node_rels[ni]; // gather scalars p_scalarQNp1[ni] = *stk::mesh::field_data(scalarQNp1, node); p_bcScalarQ[ni] = *stk::mesh::field_data(*bcScalarQ_, node); // gather vectors double * coords = stk::mesh::field_data(*coordinates_, node); const int offSet = ni*nDim; for ( int i=0; i < nDim; ++i ) { p_face_coordinates[offSet+i] = coords[i]; } } // extract the connected element to this exposed face; should be single in size! const stk::mesh::Entity* face_elem_rels = bulk_data.begin_elements(face); ThrowAssert( bulk_data.num_elements(face) == 1 ); // get element; its face ordinal number and populate face_node_ordinal_vec stk::mesh::Entity element = face_elem_rels[0]; const int face_ordinal = bulk_data.begin_element_ordinals(face)[0]; theElemTopo.side_node_ordinals(face_ordinal, face_node_ordinal_vec.begin()); // mapping from ip to nodes for this ordinal const int *ipNodeMap = meSCS->ipNodeMap(face_ordinal); //========================================== // gather nodal data off of element; n/a //========================================== stk::mesh::Entity const * elem_node_rels = bulk_data.begin_nodes(element); int num_nodes = bulk_data.num_nodes(element); // sanity check on num nodes ThrowAssert( num_nodes == nodesPerElement ); for ( int ni = 0; ni < num_nodes; ++ni ) { // set connected nodes connected_nodes[ni] = elem_node_rels[ni]; } // loop over face nodes for ( int ip = 0; ip < numScsBip; ++ip ) { const int opposingNode = meSCS->opposingNodes(face_ordinal,ip); const int nearestNode = ipNodeMap[ip]; const int offSetSF_face = ip*nodesPerFace; // left and right nodes; right is on the face; left is the opposing node stk::mesh::Entity nodeL = elem_node_rels[opposingNode]; stk::mesh::Entity nodeR = elem_node_rels[nearestNode]; // zero out vector quantities for ( int j = 0; j < nDim; ++j ) p_coordBip[j] = 0.0; // interpolate to bip double qIp = 0.0; double qIpEntrain = 0.0; for ( int ic = 0; ic < nodesPerFace; ++ic ) { const double r = p_face_shape_function[offSetSF_face+ic]; qIp += r*p_scalarQNp1[ic]; qIpEntrain += r*p_bcScalarQ[ic]; const int offSetFN = ic*nDim; for ( int j = 0; j < nDim; ++j ) { p_coordBip[j] += r*p_face_coordinates[offSetFN+j]; } } // Peclet factor; along the edge is fine const double densL = *stk::mesh::field_data(densityNp1, nodeL); const double densR = *stk::mesh::field_data(densityNp1, nodeR); const double diffCoeffL = *stk::mesh::field_data(*diffFluxCoeff_, nodeL); const double diffCoeffR = *stk::mesh::field_data(*diffFluxCoeff_, nodeR); const double scalarQNp1R = *stk::mesh::field_data(scalarQNp1, nodeR); const double *vrtmL = stk::mesh::field_data(*velocityRTM_, nodeL); const double *vrtmR = stk::mesh::field_data(*velocityRTM_, nodeR); const double *coordL = stk::mesh::field_data(*coordinates_, nodeL); const double *coordR = stk::mesh::field_data(*coordinates_, nodeR); const double *dqdxR = stk::mesh::field_data(*dqdx_, nodeR); double udotx = 0.0; double dqR = 0.0; for ( int i = 0; i < nDim; ++i ) { const double dxi = coordR[i] - coordL[i]; udotx += 0.5*dxi*(vrtmL[i] + vrtmR[i]); // extrapolation const double dx_bip = coordBip[i] - coordR[i]; dqR += dx_bip*dqdxR[i]*hoUpwind; } const double qIpUpw = scalarQNp1R + dqR; const double diffIp = 0.5*(diffCoeffL/densL + diffCoeffR/densR); const double pecfac = pecletFunction_->execute(std::abs(udotx)/(diffIp+small)); const double om_pecfac = 1.0-pecfac; //================================ // advection first (and only) //================================ const double tmdot = mdot[ip]; const int rowR = nearestNode*nodesPerElement; // advection; leaving the domain if ( tmdot > 0.0 ) { // central; is simply qIp // upwind const double qUpwind = alphaUpw*qIpUpw + (om_alphaUpw)*qIp; // total advection const double aflux = tmdot*(pecfac*qUpwind+om_pecfac*qIp); p_rhs[nearestNode] -= aflux; // upwind lhs p_lhs[rowR+nearestNode] += tmdot*pecfac*alphaUpw; // central part const double fac = tmdot*(pecfac*om_alphaUpw+om_pecfac); for ( int ic = 0; ic < nodesPerFace; ++ic ) { const double r = p_face_shape_function[offSetSF_face+ic]; const int nn = face_node_ordinal_vec[ic]; p_lhs[rowR+nn] += r*fac; } } else { // extrainment; advect in from specified value const double aflux = tmdot*qIpEntrain; p_rhs[nearestNode] -= aflux; } } apply_coeff(connected_nodes, scratchIds, scratchVals, rhs, lhs, __FILE__); } } }
//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void AssembleContinuityNonConformalSolverAlgorithm::execute() { stk::mesh::BulkData & bulk_data = realm_.bulk_data(); stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); // continuity equation scales by projection time scale const double dt = realm_.get_time_step(); const double gamma1 = realm_.get_gamma1(); const double projTimeScale = dt/gamma1; // deal with interpolation procedure const double interpTogether = realm_.get_mdot_interp(); const double om_interpTogether = 1.0-interpTogether; // space for LHS/RHS; nodesPerElem*nodesPerElem and nodesPerElem std::vector<double> lhs; std::vector<double> rhs; std::vector<int> scratchIds; std::vector<double> scratchVals; std::vector<stk::mesh::Entity> connected_nodes; // ip values; both boundary and opposing surface std::vector<double> currentIsoParCoords(nDim); std::vector<double> opposingIsoParCoords(nDim); std::vector<double> cNx(nDim); std::vector<double> oNx(nDim); std::vector<double> currentVelocityBip(nDim); std::vector<double> opposingVelocityBip(nDim); std::vector<double> currentRhoVelocityBip(nDim); std::vector<double> opposingRhoVelocityBip(nDim); std::vector<double> currentMeshVelocityBip(nDim); std::vector<double> currentRhoMeshVelocityBip(nDim); // pressure stabilization std::vector<double> currentGjpBip(nDim); std::vector<double> opposingGjpBip(nDim); std::vector<double> currentDpdxBip(nDim); std::vector<double> opposingDpdxBip(nDim); // mapping for -1:1 -> -0.5:0.5 volume element std::vector<double> currentElementIsoParCoords(nDim); std::vector<double> opposingElementIsoParCoords(nDim); // interpolate nodal values to point-in-elem const int sizeOfScalarField = 1; const int sizeOfVectorField = nDim; // pointers to fixed values double *p_cNx = &cNx[0]; double *p_oNx = &oNx[0]; // nodal fields to gather; face std::vector<double> ws_c_pressure; std::vector<double> ws_o_pressure; std::vector<double> ws_c_Gjp; std::vector<double> ws_o_Gjp; std::vector<double> ws_c_velocity; std::vector<double> ws_o_velocity; std::vector<double> ws_c_meshVelocity; // only require current std::vector<double> ws_c_density; std::vector<double> ws_o_density; std::vector<double> ws_o_coordinates; // only require opposing // element std::vector<double> ws_c_elem_pressure; std::vector<double> ws_o_elem_pressure; std::vector<double> ws_c_elem_coordinates; std::vector<double> ws_o_elem_coordinates; // master element data std::vector<double> ws_c_dndx; std::vector<double> ws_o_dndx; std::vector<double> ws_c_det_j; std::vector<double> ws_o_det_j; std::vector <double > ws_c_general_shape_function; std::vector <double > ws_o_general_shape_function; // deal with state ScalarFieldType &pressureNp1 = pressure_->field_of_state(stk::mesh::StateNP1); // parallel communicate ghosted entities if ( NULL != realm_.nonConformalManager_->nonConformalGhosting_ ) stk::mesh::communicate_field_data(*(realm_.nonConformalManager_->nonConformalGhosting_), ghostFieldVec_); // iterate nonConformalManager's dgInfoVec std::vector<NonConformalInfo *>::iterator ii; for( ii=realm_.nonConformalManager_->nonConformalInfoVec_.begin(); ii!=realm_.nonConformalManager_->nonConformalInfoVec_.end(); ++ii ) { // extract vector of DgInfo std::vector<std::vector<DgInfo *> > &dgInfoVec = (*ii)->dgInfoVec_; std::vector<std::vector<DgInfo*> >::iterator idg; for( idg=dgInfoVec.begin(); idg!=dgInfoVec.end(); ++idg ) { std::vector<DgInfo *> &faceDgInfoVec = (*idg); // now loop over all the DgInfo objects on this particular exposed face for ( size_t k = 0; k < faceDgInfoVec.size(); ++k ) { DgInfo *dgInfo = faceDgInfoVec[k]; // extract current/opposing face/element stk::mesh::Entity currentFace = dgInfo->currentFace_; stk::mesh::Entity opposingFace = dgInfo->opposingFace_; stk::mesh::Entity currentElement = dgInfo->currentElement_; stk::mesh::Entity opposingElement = dgInfo->opposingElement_; const int currentFaceOrdinal = dgInfo->currentFaceOrdinal_; const int opposingFaceOrdinal = dgInfo->opposingFaceOrdinal_; // master element; face and volume MasterElement * meFCCurrent = dgInfo->meFCCurrent_; MasterElement * meFCOpposing = dgInfo->meFCOpposing_; MasterElement * meSCSCurrent = dgInfo->meSCSCurrent_; MasterElement * meSCSOpposing = dgInfo->meSCSOpposing_; // local ip, ordinals, etc const int currentGaussPointId = dgInfo->currentGaussPointId_; currentIsoParCoords = dgInfo->currentIsoParCoords_; opposingIsoParCoords = dgInfo->opposingIsoParCoords_; // mapping from ip to nodes for this ordinal const int *ipNodeMap = meSCSCurrent->ipNodeMap(currentFaceOrdinal); // extract some master element info const int currentNodesPerFace = meFCCurrent->nodesPerElement_; const int opposingNodesPerFace = meFCOpposing->nodesPerElement_; const int currentNodesPerElement = meSCSCurrent->nodesPerElement_; const int opposingNodesPerElement = meSCSOpposing->nodesPerElement_; // resize some things; matrix related const int totalNodes = currentNodesPerElement + opposingNodesPerElement; const int lhsSize = totalNodes*totalNodes; const int rhsSize = totalNodes; lhs.resize(lhsSize); rhs.resize(rhsSize); scratchIds.resize(rhsSize); scratchVals.resize(rhsSize); connected_nodes.resize(totalNodes); // algorithm related; face ws_c_pressure.resize(currentNodesPerFace); ws_o_pressure.resize(opposingNodesPerFace); ws_c_Gjp.resize(currentNodesPerFace*nDim); ws_o_Gjp.resize(opposingNodesPerFace*nDim); ws_c_velocity.resize(currentNodesPerFace*nDim); ws_o_velocity.resize(opposingNodesPerFace*nDim); ws_c_meshVelocity.resize(currentNodesPerFace*nDim); ws_c_density.resize(currentNodesPerFace); ws_o_density.resize(opposingNodesPerFace); ws_o_coordinates.resize(opposingNodesPerFace*nDim); ws_c_general_shape_function.resize(currentNodesPerFace); ws_o_general_shape_function.resize(opposingNodesPerFace); // algorithm related; element; dndx will be at a single gauss point ws_c_elem_pressure.resize(currentNodesPerElement); ws_o_elem_pressure.resize(opposingNodesPerElement); ws_c_elem_coordinates.resize(currentNodesPerElement*nDim); ws_o_elem_coordinates.resize(opposingNodesPerElement*nDim); ws_c_dndx.resize(nDim*currentNodesPerElement); ws_o_dndx.resize(nDim*opposingNodesPerElement); ws_c_det_j.resize(1); ws_o_det_j.resize(1); // pointers double *p_lhs = &lhs[0]; double *p_rhs = &rhs[0]; // face double *p_c_pressure = &ws_c_pressure[0]; double *p_o_pressure = &ws_o_pressure[0]; double *p_c_Gjp = &ws_c_Gjp[0]; double *p_o_Gjp = &ws_o_Gjp[0]; double *p_c_velocity = &ws_c_velocity[0]; double *p_o_velocity= &ws_o_velocity[0]; double *p_c_meshVelocity = &ws_c_meshVelocity[0]; double *p_c_density = &ws_c_density[0]; double *p_o_density = &ws_o_density[0]; double *p_o_coordinates = &ws_o_coordinates[0]; // element double *p_c_elem_pressure = &ws_c_elem_pressure[0]; double *p_o_elem_pressure = &ws_o_elem_pressure[0]; double *p_c_elem_coordinates = &ws_c_elem_coordinates[0]; double *p_o_elem_coordinates = &ws_o_elem_coordinates[0]; // me pointers double *p_c_general_shape_function = &ws_c_general_shape_function[0]; double *p_o_general_shape_function = &ws_o_general_shape_function[0]; double *p_c_dndx = &ws_c_dndx[0]; double *p_o_dndx = &ws_o_dndx[0]; // populate current face_node_ordinals const int *c_face_node_ordinals = meSCSCurrent->side_node_ordinals(currentFaceOrdinal); // gather current face data stk::mesh::Entity const* current_face_node_rels = bulk_data.begin_nodes(currentFace); const int current_num_face_nodes = bulk_data.num_nodes(currentFace); for ( int ni = 0; ni < current_num_face_nodes; ++ni ) { stk::mesh::Entity node = current_face_node_rels[ni]; // gather; scalar p_c_pressure[ni] = *stk::mesh::field_data(pressureNp1, node); p_c_density[ni] = *stk::mesh::field_data(*density_, node); // gather; vector const double *velocity = stk::mesh::field_data(*velocity_, node ); const double *meshVelocity = stk::mesh::field_data(*meshVelocity_, node ); const double *Gjp = stk::mesh::field_data(*Gjp_, node ); for ( int i = 0; i < nDim; ++i ) { const int offSet = i*current_num_face_nodes + ni; p_c_velocity[offSet] = velocity[i]; p_c_meshVelocity[offSet] = meshVelocity[i]; p_c_Gjp[offSet] = Gjp[i]; } } // populate opposing face_node_ordinals const int *o_face_node_ordinals = meSCSOpposing->side_node_ordinals(opposingFaceOrdinal); // gather opposing face data stk::mesh::Entity const* opposing_face_node_rels = bulk_data.begin_nodes(opposingFace); const int opposing_num_face_nodes = bulk_data.num_nodes(opposingFace); for ( int ni = 0; ni < opposing_num_face_nodes; ++ni ) { stk::mesh::Entity node = opposing_face_node_rels[ni]; // gather; scalar p_o_pressure[ni] = *stk::mesh::field_data(pressureNp1, node); p_o_density[ni] = *stk::mesh::field_data(*density_, node); // gather; vector const double *velocity = stk::mesh::field_data(*velocity_, node ); const double *Gjp = stk::mesh::field_data(*Gjp_, node ); const double *coords = stk::mesh::field_data(*coordinates_, node); for ( int i = 0; i < nDim; ++i ) { const int offSet = i*opposing_num_face_nodes + ni; p_o_velocity[offSet] = velocity[i]; p_o_Gjp[offSet] = Gjp[i]; p_o_coordinates[ni*nDim+i] = coords[i]; } } // gather current element data stk::mesh::Entity const* current_elem_node_rels = bulk_data.begin_nodes(currentElement); const int current_num_elem_nodes = bulk_data.num_nodes(currentElement); for ( int ni = 0; ni < current_num_elem_nodes; ++ni ) { stk::mesh::Entity node = current_elem_node_rels[ni]; // set connected nodes connected_nodes[ni] = node; // gather; scalar p_c_elem_pressure[ni] = *stk::mesh::field_data(pressureNp1, node); // gather; vector const double *coords = stk::mesh::field_data(*coordinates_, node); const int niNdim = ni*nDim; for ( int i = 0; i < nDim; ++i ) { p_c_elem_coordinates[niNdim+i] = coords[i]; } } // gather opposing element data; sneak in second connected nodes stk::mesh::Entity const* opposing_elem_node_rels = bulk_data.begin_nodes(opposingElement); const int opposing_num_elem_nodes = bulk_data.num_nodes(opposingElement); for ( int ni = 0; ni < opposing_num_elem_nodes; ++ni ) { stk::mesh::Entity node = opposing_elem_node_rels[ni]; // set connected nodes connected_nodes[ni+current_num_elem_nodes] = node; // gather; scalar p_o_elem_pressure[ni] = *stk::mesh::field_data(pressureNp1, node); // gather; vector const double *coords = stk::mesh::field_data(*coordinates_, node); const int niNdim = ni*nDim; for ( int i = 0; i < nDim; ++i ) { p_o_elem_coordinates[niNdim+i] = coords[i]; } } // compute opposing normal through master element call, not using oppoing exposed area meFCOpposing->general_normal(&opposingIsoParCoords[0], &p_o_coordinates[0], &p_oNx[0]); // pointer to face data const double * c_areaVec = stk::mesh::field_data(*exposedAreaVec_, currentFace); double c_amag = 0.0; for ( int j = 0; j < nDim; ++j ) { const double c_axj = c_areaVec[currentGaussPointId*nDim+j]; c_amag += c_axj*c_axj; } c_amag = std::sqrt(c_amag); // now compute normal for ( int i = 0; i < nDim; ++i ) { p_cNx[i] = c_areaVec[currentGaussPointId*nDim+i]/c_amag; } // override opposing normal if ( useCurrentNormal_ ) { for ( int i = 0; i < nDim; ++i ) p_oNx[i] = -p_cNx[i]; } // project from side to element; method deals with the -1:1 isInElement range to the proper underlying CVFEM range meSCSCurrent->sidePcoords_to_elemPcoords(currentFaceOrdinal, 1, ¤tIsoParCoords[0], ¤tElementIsoParCoords[0]); meSCSOpposing->sidePcoords_to_elemPcoords(opposingFaceOrdinal, 1, &opposingIsoParCoords[0], &opposingElementIsoParCoords[0]); // compute dndx double scs_error = 0.0; meSCSCurrent->general_face_grad_op(currentFaceOrdinal, ¤tElementIsoParCoords[0], &p_c_elem_coordinates[0], &p_c_dndx[0], &ws_c_det_j[0], &scs_error); meSCSOpposing->general_face_grad_op(opposingFaceOrdinal, &opposingElementIsoParCoords[0], &p_o_elem_coordinates[0], &p_o_dndx[0], &ws_o_det_j[0], &scs_error); // current inverse length scale; can loop over face nodes to avoid "nodesOnFace" array double currentInverseLength = 0.0; for ( int ic = 0; ic < current_num_face_nodes; ++ic ) { const int faceNodeNumber = c_face_node_ordinals[ic]; const int offSetDnDx = faceNodeNumber*nDim; // single intg. point for ( int j = 0; j < nDim; ++j ) { const double nxj = p_cNx[j]; const double dndxj = p_c_dndx[offSetDnDx+j]; currentInverseLength += dndxj*nxj; } } // opposing inverse length scale; can loop over face nodes to avoid "nodesOnFace" array double opposingInverseLength = 0.0; for ( int ic = 0; ic < opposing_num_face_nodes; ++ic ) { const int faceNodeNumber = o_face_node_ordinals[ic]; const int offSetDnDx = faceNodeNumber*nDim; // single intg. point for ( int j = 0; j < nDim; ++j ) { const double nxj = p_oNx[j]; const double dndxj = p_o_dndx[offSetDnDx+j]; opposingInverseLength += dndxj*nxj; } } // projected nodal gradient; zero out for ( int j = 0; j < nDim; ++j ) { currentDpdxBip[j] = 0.0; opposingDpdxBip[j] = 0.0; } // current pressure gradient for ( int ic = 0; ic < currentNodesPerElement; ++ic ) { const int offSetDnDx = ic*nDim; // single intg. point const double pNp1 = p_c_elem_pressure[ic]; for ( int j = 0; j < nDim; ++j ) { const double dndxj = p_c_dndx[offSetDnDx+j]; currentDpdxBip[j] += dndxj*pNp1; } } // opposing pressure gradient for ( int ic = 0; ic < opposingNodesPerElement; ++ic ) { const int offSetDnDx = ic*nDim; // single intg. point const double pNp1 = p_o_elem_pressure[ic]; for ( int j = 0; j < nDim; ++j ) { const double dndxj = p_o_dndx[offSetDnDx+j]; opposingDpdxBip[j] += dndxj*pNp1; } } // interpolate to boundary ips double currentPressureBip = 0.0; meFCCurrent->interpolatePoint( sizeOfScalarField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_pressure[0], ¤tPressureBip); double opposingPressureBip = 0.0; meFCOpposing->interpolatePoint( sizeOfScalarField, &(dgInfo->opposingIsoParCoords_[0]), &ws_o_pressure[0], &opposingPressureBip); // velocity meFCCurrent->interpolatePoint( sizeOfVectorField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_velocity[0], ¤tVelocityBip[0]); meFCOpposing->interpolatePoint( sizeOfVectorField, &(dgInfo->opposingIsoParCoords_[0]), &ws_o_velocity[0], &opposingVelocityBip[0]); // mesh velocity; only required at current meFCCurrent->interpolatePoint( sizeOfVectorField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_meshVelocity[0], ¤tMeshVelocityBip[0]); // projected nodal gradient meFCCurrent->interpolatePoint( sizeOfVectorField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_Gjp[0], ¤tGjpBip[0]); meFCOpposing->interpolatePoint( sizeOfVectorField, &(dgInfo->opposingIsoParCoords_[0]), &ws_o_Gjp[0], &opposingGjpBip[0]); // density double currentDensityBip = 0.0; meFCCurrent->interpolatePoint( sizeOfScalarField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_density[0], ¤tDensityBip); double opposingDensityBip = 0.0; meFCOpposing->interpolatePoint( sizeOfScalarField, &(dgInfo->opposingIsoParCoords_[0]), &ws_o_density[0], &opposingDensityBip); // product of density and velocity; current (take over previous nodal value for velocity) for ( int ni = 0; ni < current_num_face_nodes; ++ni ) { const double density = p_c_density[ni]; for ( int i = 0; i < nDim; ++i ) { const int offSet = i*current_num_face_nodes + ni; p_c_velocity[offSet] *= density; p_c_meshVelocity[offSet] *= density; } } // opposite for ( int ni = 0; ni < opposing_num_face_nodes; ++ni ) { const double density = p_o_density[ni]; for ( int i = 0; i < nDim; ++i ) { const int offSet = i*opposing_num_face_nodes + ni; p_o_velocity[offSet] *= density; } } // interpolate velocity with density scaling meFCCurrent->interpolatePoint( sizeOfVectorField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_velocity[0], ¤tRhoVelocityBip[0]); meFCOpposing->interpolatePoint( sizeOfVectorField, &(dgInfo->opposingIsoParCoords_[0]), &ws_o_velocity[0], &opposingRhoVelocityBip[0]); // interpolate mesh velocity with density scaling; only current meFCCurrent->interpolatePoint( sizeOfVectorField, &(dgInfo->currentIsoParCoords_[0]), &ws_c_meshVelocity[0], ¤tRhoMeshVelocityBip[0]); // zero lhs/rhs for ( int p = 0; p < lhsSize; ++p ) p_lhs[p] = 0.0; for ( int p = 0; p < rhsSize; ++p ) p_rhs[p] = 0.0; const double penaltyIp = projTimeScale*0.5*(currentInverseLength + opposingInverseLength); double ncFlux = 0.0; double ncPstabFlux = 0.0; for ( int j = 0; j < nDim; ++j ) { const double cRhoVelocity = interpTogether*currentRhoVelocityBip[j] + om_interpTogether*currentDensityBip*currentVelocityBip[j]; const double oRhoVelocity = interpTogether*opposingRhoVelocityBip[j] + om_interpTogether*opposingDensityBip*opposingVelocityBip[j]; const double cRhoMeshVelocity = interpTogether*currentRhoMeshVelocityBip[j] + om_interpTogether*currentDensityBip*currentMeshVelocityBip[j]; ncFlux += 0.5*(cRhoVelocity*p_cNx[j] - oRhoVelocity*p_oNx[j]) - meshMotionFac_*cRhoMeshVelocity*p_cNx[j]; const double cPstab = currentDpdxBip[j] - currentGjpBip[j]; const double oPstab = opposingDpdxBip[j] - opposingGjpBip[j]; ncPstabFlux += 0.5*(cPstab*p_cNx[j] - oPstab*p_oNx[j]); } const double mdot = (ncFlux - includePstab_*projTimeScale*ncPstabFlux + penaltyIp*(currentPressureBip - opposingPressureBip))*c_amag; // form residual const int nn = ipNodeMap[currentGaussPointId]; p_rhs[nn] -= mdot/projTimeScale; // set-up row for matrix const int rowR = nn*totalNodes; double lhsFac = penaltyIp*c_amag/projTimeScale; // sensitivities; current face (penalty); use general shape function for this single ip meFCCurrent->general_shape_fcn(1, ¤tIsoParCoords[0], &ws_c_general_shape_function[0]); for ( int ic = 0; ic < currentNodesPerFace; ++ic ) { const int icnn = c_face_node_ordinals[ic]; const double r = p_c_general_shape_function[ic]; p_lhs[rowR+icnn] += r*lhsFac; } // sensitivities; current element (diffusion) for ( int ic = 0; ic < currentNodesPerElement; ++ic ) { const int offSetDnDx = ic*nDim; // single intg. point double lhscd = 0.0; for ( int j = 0; j < nDim; ++j ) { const double nxj = p_cNx[j]; const double dndxj = p_c_dndx[offSetDnDx+j]; lhscd -= dndxj*nxj; } p_lhs[rowR+ic] += 0.5*lhscd*c_amag*includePstab_; } // sensitivities; opposing face (penalty); use general shape function for this single ip meFCOpposing->general_shape_fcn(1, &opposingIsoParCoords[0], &ws_o_general_shape_function[0]); for ( int ic = 0; ic < opposingNodesPerFace; ++ic ) { const int icnn = o_face_node_ordinals[ic]; const double r = p_o_general_shape_function[ic]; p_lhs[rowR+icnn+currentNodesPerElement] -= r*lhsFac; } // sensitivities; opposing element (diffusion) for ( int ic = 0; ic < opposingNodesPerElement; ++ic ) { const int offSetDnDx = ic*nDim; // single intg. point double lhscd = 0.0; for ( int j = 0; j < nDim; ++j ) { const double nxj = p_oNx[j]; const double dndxj = p_o_dndx[offSetDnDx+j]; lhscd -= dndxj*nxj; } p_lhs[rowR+ic+currentNodesPerElement] -= 0.5*lhscd*c_amag*includePstab_; } apply_coeff(connected_nodes, scratchIds, scratchVals, rhs, lhs, __FILE__); } } } }
//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void AssembleContinuityElemOpenSolverAlgorithm::execute() { stk::mesh::BulkData & bulk_data = realm_.bulk_data(); stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); // extract noc const std::string dofName = "pressure"; const double includeNOC = (realm_.get_noc_usage(dofName) == true) ? 1.0 : 0.0; // space for LHS/RHS; nodesPerElem*nodesPerElem and nodesPerElem std::vector<double> lhs; std::vector<double> rhs; std::vector<stk::mesh::Entity> connected_nodes; // ip values; both boundary and opposing surface std::vector<double> uBip(nDim); std::vector<double> rho_uBip(nDim); std::vector<double> GpdxBip(nDim); std::vector<double> coordBip(nDim); std::vector<double> coordScs(nDim); // pointers to fixed values double *p_uBip = &uBip[0]; double *p_rho_uBip = &rho_uBip[0]; double *p_GpdxBip = &GpdxBip[0]; double *p_coordBip = &coordBip[0]; double *p_coordScs = &coordScs[0]; // nodal fields to gather std::vector<double> ws_coordinates; std::vector<double> ws_pressure; std::vector<double> ws_vrtm; std::vector<double> ws_Gpdx; std::vector<double> ws_density; std::vector<double> ws_bcPressure; // master element std::vector<double> ws_shape_function; std::vector<double> ws_shape_function_lhs; std::vector<double> ws_face_shape_function; // time step const double dt = realm_.get_time_step(); const double gamma1 = realm_.get_gamma1(); const double projTimeScale = dt/gamma1; // deal with interpolation procedure const double interpTogether = realm_.get_mdot_interp(); const double om_interpTogether = 1.0-interpTogether; // deal with state ScalarFieldType &densityNp1 = density_->field_of_state(stk::mesh::StateNP1); // define vector of parent topos; should always be UNITY in size std::vector<stk::topology> parentTopo; // define some common selectors stk::mesh::Selector s_locally_owned_union = meta_data.locally_owned_part() &stk::mesh::selectUnion(partVec_); stk::mesh::BucketVector const& face_buckets = realm_.get_buckets( meta_data.side_rank(), s_locally_owned_union ); for ( stk::mesh::BucketVector::const_iterator ib = face_buckets.begin(); ib != face_buckets.end() ; ++ib ) { stk::mesh::Bucket & b = **ib ; // extract connected element topology b.parent_topology(stk::topology::ELEMENT_RANK, parentTopo); ThrowAssert ( parentTopo.size() == 1 ); stk::topology theElemTopo = parentTopo[0]; // volume master element MasterElement *meSCS = realm_.get_surface_master_element(theElemTopo); const int nodesPerElement = meSCS->nodesPerElement_; const int numScsIp = meSCS->numIntPoints_; // face master element MasterElement *meFC = realm_.get_surface_master_element(b.topology()); const int nodesPerFace = b.topology().num_nodes(); const int numScsBip = meFC->numIntPoints_; std::vector<int> face_node_ordinal_vec(nodesPerFace); // resize some things; matrix related const int lhsSize = nodesPerElement*nodesPerElement; const int rhsSize = nodesPerElement; lhs.resize(lhsSize); rhs.resize(rhsSize); connected_nodes.resize(nodesPerElement); // algorithm related; element ws_coordinates.resize(nodesPerElement*nDim); ws_pressure.resize(nodesPerElement); ws_vrtm.resize(nodesPerFace*nDim); ws_Gpdx.resize(nodesPerFace*nDim); ws_density.resize(nodesPerFace); ws_bcPressure.resize(nodesPerFace); ws_shape_function.resize(numScsIp*nodesPerElement); ws_shape_function_lhs.resize(numScsIp*nodesPerElement); ws_face_shape_function.resize(numScsBip*nodesPerFace); // pointers double *p_lhs = &lhs[0]; double *p_rhs = &rhs[0]; double *p_coordinates = &ws_coordinates[0]; double *p_pressure = &ws_pressure[0]; double *p_vrtm = &ws_vrtm[0]; double *p_Gpdx = &ws_Gpdx[0]; double *p_density = &ws_density[0]; double *p_bcPressure = &ws_bcPressure[0]; double *p_shape_function = &ws_shape_function[0]; double *p_shape_function_lhs = shiftPoisson_ ? &ws_shape_function[0] : reducedSensitivities_ ? &ws_shape_function_lhs[0] : &ws_shape_function[0]; double *p_face_shape_function = &ws_face_shape_function[0]; // shape functions; interior if ( shiftPoisson_ ) meSCS->shifted_shape_fcn(&p_shape_function[0]); else meSCS->shape_fcn(&p_shape_function[0]); if ( !shiftPoisson_ && reducedSensitivities_ ) meSCS->shifted_shape_fcn(&p_shape_function_lhs[0]); // shape functions; boundary if ( shiftMdot_ ) meFC->shifted_shape_fcn(&p_face_shape_function[0]); else meFC->shape_fcn(&p_face_shape_function[0]); const stk::mesh::Bucket::size_type length = b.size(); for ( stk::mesh::Bucket::size_type k = 0 ; k < length ; ++k ) { // zero lhs/rhs for ( int p = 0; p < lhsSize; ++p ) p_lhs[p] = 0.0; for ( int p = 0; p < rhsSize; ++p ) p_rhs[p] = 0.0; // get face stk::mesh::Entity face = b[k]; //====================================== // gather nodal data off of face //====================================== stk::mesh::Entity const * face_node_rels = bulk_data.begin_nodes(face); int num_face_nodes = bulk_data.num_nodes(face); // sanity check on num nodes ThrowAssert( num_face_nodes == nodesPerFace ); for ( int ni = 0; ni < num_face_nodes; ++ni ) { stk::mesh::Entity node = face_node_rels[ni]; // gather scalars p_density[ni] = *stk::mesh::field_data(densityNp1, node); p_bcPressure[ni] = *stk::mesh::field_data(*pressureBc_, node); // gather vectors const double * vrtm = stk::mesh::field_data(*velocityRTM_, node); const double * Gjp = stk::mesh::field_data(*Gpdx_, node); const int offSet = ni*nDim; for ( int j=0; j < nDim; ++j ) { p_vrtm[offSet+j] = vrtm[j]; p_Gpdx[offSet+j] = Gjp[j]; } } // pointer to face data const double * areaVec = stk::mesh::field_data(*exposedAreaVec_, face); // extract the connected element to this exposed face; should be single in size! const stk::mesh::Entity* face_elem_rels = bulk_data.begin_elements(face); ThrowAssert( bulk_data.num_elements(face) == 1 ); // get element; its face ordinal number and populate face_node_ordinal_vec stk::mesh::Entity element = face_elem_rels[0]; const stk::mesh::ConnectivityOrdinal* face_elem_ords = bulk_data.begin_element_ordinals(face); const int face_ordinal = face_elem_ords[0]; theElemTopo.side_node_ordinals(face_ordinal, face_node_ordinal_vec.begin()); // mapping from ip to nodes for this ordinal const int *ipNodeMap = meSCS->ipNodeMap(face_ordinal); //====================================== // gather nodal data off of element //====================================== stk::mesh::Entity const * elem_node_rels = bulk_data.begin_nodes(element); int num_nodes = bulk_data.num_nodes(element); // sanity check on num nodes ThrowAssert( num_nodes == nodesPerElement ); for ( int ni = 0; ni < num_nodes; ++ni ) { stk::mesh::Entity node = elem_node_rels[ni]; // set connected nodes connected_nodes[ni] = node; // gather scalars p_pressure[ni] = *stk::mesh::field_data(*pressure_, node); // gather vectors const double * coords = stk::mesh::field_data(*coordinates_, node); const int offSet = ni*nDim; for ( int j=0; j < nDim; ++j ) { p_coordinates[offSet+j] = coords[j]; } } // loop over boundary ips for ( int ip = 0; ip < numScsBip; ++ip ) { const int nearestNode = ipNodeMap[ip]; const int opposingScsIp = meSCS->opposingFace(face_ordinal,ip); // zero out vector quantities for ( int j = 0; j < nDim; ++j ) { p_uBip[j] = 0.0; p_rho_uBip[j] = 0.0; p_GpdxBip[j] = 0.0; p_coordBip[j] = 0.0; p_coordScs[j] = 0.0; } double rhoBip = 0.0; // interpolate to bip double pBip = 0.0; const int offSetSF_face = ip*nodesPerFace; for ( int ic = 0; ic < nodesPerFace; ++ic ) { const int fn = face_node_ordinal_vec[ic]; const double r = p_face_shape_function[offSetSF_face+ic]; const double rhoIC = p_density[ic]; rhoBip += r*rhoIC; pBip += r*p_bcPressure[ic]; const int offSetFN = ic*nDim; const int offSetEN = fn*nDim; for ( int j = 0; j < nDim; ++j ) { p_uBip[j] += r*p_vrtm[offSetFN+j]; p_rho_uBip[j] += r*rhoIC*p_vrtm[offSetFN+j]; p_GpdxBip[j] += r*p_Gpdx[offSetFN+j]; p_coordBip[j] += r*p_coordinates[offSetEN+j]; } } // data at interior opposing face double pScs = 0.0; const int offSetSF_elem = opposingScsIp*nodesPerElement; for ( int ic = 0; ic < nodesPerElement; ++ic ) { const double r = p_shape_function[offSetSF_elem+ic]; pScs += r*p_pressure[ic]; const int offSet = ic*nDim; for ( int j = 0; j < nDim; ++j ) { p_coordScs[j] += r*p_coordinates[offSet+j]; } } // form axdx, asq and mdot (without dp/dn or noc) double asq = 0.0; double axdx = 0.0; double mdot = 0.0; for ( int j = 0; j < nDim; ++j ) { const double dxj = p_coordBip[j] - p_coordScs[j]; const double axj = areaVec[ip*nDim+j]; asq += axj*axj; axdx += axj*dxj; mdot += (interpTogether*p_rho_uBip[j] + om_interpTogether*rhoBip*p_uBip[j] + projTimeScale*p_GpdxBip[j])*axj; } const double inv_axdx = 1.0/axdx; // deal with noc double noc = 0.0; for ( int j = 0; j < nDim; ++j ) { const double dxj = p_coordBip[j] - p_coordScs[j]; const double axj = areaVec[ip*nDim+j]; const double kxj = axj - asq*inv_axdx*dxj; // NOC noc += kxj*p_GpdxBip[j]; } // lhs for pressure system int rowR = nearestNode*nodesPerElement; for ( int ic = 0; ic < nodesPerElement; ++ic ) { const double r = p_shape_function_lhs[offSetSF_elem+ic]; p_lhs[rowR+ic] += r*asq*inv_axdx; } // final mdot mdot += -projTimeScale*((pBip-pScs)*asq*inv_axdx + noc*includeNOC); // residual p_rhs[nearestNode] -= mdot/projTimeScale; } apply_coeff(connected_nodes, rhs, lhs, __FILE__); } } }
//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void AssembleMomentumElemSymmetrySolverAlgorithm::execute() { stk::mesh::BulkData & bulk_data = realm_.bulk_data(); stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); // space for LHS/RHS; nodesPerElem*nDim*nodesPerElem*nDim and nodesPerElem*nDim std::vector<double> lhs; std::vector<double> rhs; std::vector<int> scratchIds; std::vector<double> scratchVals; std::vector<stk::mesh::Entity> connected_nodes; // vectors std::vector<double> nx(nDim); // pointers to fixed values double *p_nx = &nx[0]; // nodal fields to gather std::vector<double> ws_velocityNp1; std::vector<double> ws_coordinates; std::vector<double> ws_viscosity; // master element std::vector<double> ws_face_shape_function; std::vector<double> ws_dndx; std::vector<double> ws_det_j; // deal with state VectorFieldType &velocityNp1 = velocity_->field_of_state(stk::mesh::StateNP1); // define vector of parent topos; should always be UNITY in size std::vector<stk::topology> parentTopo; // define some common selectors stk::mesh::Selector s_locally_owned_union = meta_data.locally_owned_part() &stk::mesh::selectUnion(partVec_); stk::mesh::BucketVector const& face_buckets = realm_.get_buckets( meta_data.side_rank(), s_locally_owned_union ); for ( stk::mesh::BucketVector::const_iterator ib = face_buckets.begin(); ib != face_buckets.end() ; ++ib ) { stk::mesh::Bucket & b = **ib ; // extract connected element topology b.parent_topology(stk::topology::ELEMENT_RANK, parentTopo); ThrowAssert ( parentTopo.size() == 1 ); stk::topology theElemTopo = parentTopo[0]; // volume master element MasterElement *meSCS = realm_.get_surface_master_element(theElemTopo); const int nodesPerElement = meSCS->nodesPerElement_; // face master element MasterElement *meFC = realm_.get_surface_master_element(b.topology()); const int nodesPerFace = meFC->nodesPerElement_; const int numScsBip = meFC->numIntPoints_; // resize some things; matrix related const int lhsSize = nodesPerElement*nDim*nodesPerElement*nDim; const int rhsSize = nodesPerElement*nDim; lhs.resize(lhsSize); rhs.resize(rhsSize); scratchIds.resize(rhsSize); scratchVals.resize(rhsSize); connected_nodes.resize(nodesPerElement); // algorithm related; element ws_velocityNp1.resize(nodesPerElement*nDim); ws_coordinates.resize(nodesPerElement*nDim); ws_viscosity.resize(nodesPerFace); ws_face_shape_function.resize(numScsBip*nodesPerFace); ws_dndx.resize(nDim*numScsBip*nodesPerElement); ws_det_j.resize(numScsBip); // pointers double *p_lhs = &lhs[0]; double *p_rhs = &rhs[0]; double *p_velocityNp1 = &ws_velocityNp1[0]; double *p_coordinates = &ws_coordinates[0]; double *p_viscosity = &ws_viscosity[0]; double *p_face_shape_function = &ws_face_shape_function[0]; double *p_dndx = &ws_dndx[0]; // shape function meFC->shape_fcn(&p_face_shape_function[0]); const stk::mesh::Bucket::size_type length = b.size(); for ( stk::mesh::Bucket::size_type k = 0 ; k < length ; ++k ) { // zero lhs/rhs for ( int p = 0; p < lhsSize; ++p ) p_lhs[p] = 0.0; for ( int p = 0; p < rhsSize; ++p ) p_rhs[p] = 0.0; // get face stk::mesh::Entity face = b[k]; //====================================== // gather nodal data off of face //====================================== stk::mesh::Entity const * face_node_rels = bulk_data.begin_nodes(face); int num_face_nodes = bulk_data.num_nodes(face); // sanity check on num nodes ThrowAssert( num_face_nodes == nodesPerFace ); for ( int ni = 0; ni < num_face_nodes; ++ni ) { stk::mesh::Entity node = face_node_rels[ni]; // gather scalars p_viscosity[ni] = *stk::mesh::field_data(*viscosity_, node); } // pointer to face data const double * areaVec = stk::mesh::field_data(*exposedAreaVec_, face); // extract the connected element to this exposed face; should be single in size! stk::mesh::Entity const * face_elem_rels = bulk_data.begin_elements(face); ThrowAssert( bulk_data.num_elements(face) == 1 ); // get element; its face ordinal number stk::mesh::Entity element = face_elem_rels[0]; const stk::mesh::ConnectivityOrdinal* face_elem_ords = bulk_data.begin_element_ordinals(face); const int face_ordinal = face_elem_ords[0]; // mapping from ip to nodes for this ordinal const int *ipNodeMap = meSCS->ipNodeMap(face_ordinal); //========================================== // gather nodal data off of element //========================================== stk::mesh::Entity const * elem_node_rels = bulk_data.begin_nodes(element); int num_nodes = bulk_data.num_nodes(element); // sanity check on num nodes ThrowAssert( num_nodes == nodesPerElement ); for ( int ni = 0; ni < num_nodes; ++ni ) { stk::mesh::Entity node = elem_node_rels[ni]; // set connected nodes connected_nodes[ni] = node; // gather vectors double * uNp1 = stk::mesh::field_data(velocityNp1, node); double * coords = stk::mesh::field_data(*coordinates_, node); const int offSet = ni*nDim; for ( int j=0; j < nDim; ++j ) { p_velocityNp1[offSet+j] = uNp1[j]; p_coordinates[offSet+j] = coords[j]; } } // compute dndx double scs_error = 0.0; meSCS->face_grad_op(1, face_ordinal, &p_coordinates[0], &p_dndx[0], &ws_det_j[0], &scs_error); // loop over boundary ips for ( int ip = 0; ip < numScsBip; ++ip ) { const int nearestNode = ipNodeMap[ip]; // offset for bip area vector and types of shape function const int faceOffSet = ip*nDim; const int offSetSF_face = ip*nodesPerFace; // form unit normal double asq = 0.0; for ( int j = 0; j < nDim; ++j ) { const double axj = areaVec[faceOffSet+j]; asq += axj*axj; } const double amag = std::sqrt(asq); for ( int i = 0; i < nDim; ++i ) { p_nx[i] = areaVec[faceOffSet+i]/amag; } // interpolate to bip double viscBip = 0.0; for ( int ic = 0; ic < nodesPerFace; ++ic ) { const double r = p_face_shape_function[offSetSF_face+ic]; viscBip += r*p_viscosity[ic]; } //================================ // diffusion second //================================ for ( int ic = 0; ic < nodesPerElement; ++ic ) { const int offSetDnDx = nDim*nodesPerElement*ip + ic*nDim; for ( int j = 0; j < nDim; ++j ) { const double axj = areaVec[faceOffSet+j]; const double dndxj = p_dndx[offSetDnDx+j]; const double uxj = p_velocityNp1[ic*nDim+j]; const double divUstress = 2.0/3.0*viscBip*dndxj*uxj*axj*includeDivU_; for ( int i = 0; i < nDim; ++i ) { // matrix entries int indexR = nearestNode*nDim + i; int rowR = indexR*nodesPerElement*nDim; const double dndxi = p_dndx[offSetDnDx+i]; const double uxi = p_velocityNp1[ic*nDim+i]; const double nxi = p_nx[i]; const double nxinxi = nxi*nxi; // -mu*dui/dxj*Aj*ni*ni; sneak in divU (explicit) double lhsfac = - viscBip*dndxj*axj*nxinxi; p_lhs[rowR+ic*nDim+i] += lhsfac; p_rhs[indexR] -= lhsfac*uxi + divUstress*nxinxi; // -mu*duj/dxi*Aj*ni*ni lhsfac = - viscBip*dndxi*axj*nxinxi; p_lhs[rowR+ic*nDim+j] += lhsfac; p_rhs[indexR] -= lhsfac*uxj; // now we need the +nx*ny*Fy + nx*nz*Fz part for ( int l = 0; l < nDim; ++l ) { if ( i != l ) { const double nxinxl = nxi*p_nx[l]; const double uxl = p_velocityNp1[ic*nDim+l]; const double dndxl = p_dndx[offSetDnDx+l]; // -ni*nl*mu*dul/dxj*Aj; sneak in divU (explict) lhsfac = -viscBip*dndxj*axj*nxinxl; p_lhs[rowR+ic*nDim+l] += lhsfac; p_rhs[indexR] -= lhsfac*uxl + divUstress*nxinxl; // -ni*nl*mu*duj/dxl*Aj lhsfac = -viscBip*dndxl*axj*nxinxl; p_lhs[rowR+ic*nDim+j] += lhsfac; p_rhs[indexR] -= lhsfac*uxj; } } } } } } apply_coeff(connected_nodes, scratchIds, scratchVals, rhs, lhs, __FILE__); } } }
//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void AssemblePNGBoundarySolverAlgorithm::execute() { stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); // space for LHS/RHS; nodesPerFace*nDim*nodesPerFace*nDim and nodesPerFace*nDim std::vector<double> lhs; std::vector<double> rhs; std::vector<int> scratchIds; std::vector<double> scratchVals; std::vector<stk::mesh::Entity> connected_nodes; // nodal fields to gather std::vector<double> ws_scalarQ; // master element std::vector<double> ws_face_shape_function; // define some common selectors stk::mesh::Selector s_locally_owned_union = meta_data.locally_owned_part() &stk::mesh::selectUnion(partVec_); stk::mesh::BucketVector const& face_buckets = realm_.get_buckets( meta_data.side_rank(), s_locally_owned_union ); for ( stk::mesh::BucketVector::const_iterator ib = face_buckets.begin(); ib != face_buckets.end() ; ++ib ) { stk::mesh::Bucket & b = **ib ; // face master element MasterElement *meFC = realm_.get_surface_master_element(b.topology()); const int nodesPerFace = meFC->nodesPerElement_; const int numScsBip = meFC->numIntPoints_; const int *faceIpNodeMap = meFC->ipNodeMap(); // resize some things; matrix related const int lhsSize = nodesPerFace*nDim*nodesPerFace*nDim; const int rhsSize = nodesPerFace*nDim; lhs.resize(lhsSize); rhs.resize(rhsSize); scratchIds.resize(rhsSize); scratchVals.resize(rhsSize); connected_nodes.resize(nodesPerFace); // algorithm related; element ws_scalarQ.resize(nodesPerFace); ws_face_shape_function.resize(numScsBip*nodesPerFace); // pointers double *p_lhs = &lhs[0]; double *p_rhs = &rhs[0]; double *p_scalarQ = &ws_scalarQ[0]; double *p_face_shape_function = &ws_face_shape_function[0]; // zero lhs; always zero for ( int p = 0; p < lhsSize; ++p ) p_lhs[p] = 0.0; // shape function meFC->shape_fcn(&p_face_shape_function[0]); const stk::mesh::Bucket::size_type length = b.size(); for ( stk::mesh::Bucket::size_type k = 0 ; k < length ; ++k ) { // zero rhs only since LHS never contributes, never touched for ( int p = 0; p < rhsSize; ++p ) p_rhs[p] = 0.0; //====================================== // gather nodal data off of face //====================================== stk::mesh::Entity const * face_node_rels = b.begin_nodes(k); int num_face_nodes = b.num_nodes(k); // sanity check on num nodes ThrowAssert( num_face_nodes == nodesPerFace ); for ( int ni = 0; ni < num_face_nodes; ++ni ) { // get the node and form connected_node stk::mesh::Entity node = face_node_rels[ni]; connected_nodes[ni] = node; // gather scalars p_scalarQ[ni] = *stk::mesh::field_data(*scalarQ_, node); } // pointer to face data const double * areaVec = stk::mesh::field_data(*exposedAreaVec_, b, k); // start the assembly for ( int ip = 0; ip < numScsBip; ++ip ) { // nearest node to ip const int localFaceNode = faceIpNodeMap[ip]; // save off some offsets for this ip const int nnNdim = localFaceNode*nDim; const int offSetSF_face = ip*nodesPerFace; // interpolate to bip double scalarQBip = 0.0; for ( int ic = 0; ic < nodesPerFace; ++ic ) { const double r = p_face_shape_function[offSetSF_face+ic]; scalarQBip += r*p_scalarQ[ic]; } // assemble to RHS; rhs -= a negative contribution => += for ( int i = 0; i < nDim; ++i ) { p_rhs[nnNdim+i] += scalarQBip*areaVec[ip*nDim+i]; } } apply_coeff(connected_nodes, scratchIds, scratchVals, rhs, lhs, __FILE__); } } }
//-------------------------------------------------------------------------- //-------- execute --------------------------------------------------------- //-------------------------------------------------------------------------- void ComputeHeatTransferElemWallAlgorithm::execute() { stk::mesh::BulkData & bulk_data = realm_.bulk_data(); stk::mesh::MetaData & meta_data = realm_.meta_data(); const int nDim = meta_data.spatial_dimension(); const double dt = realm_.get_time_step(); // nodal fields to gather std::vector<double> ws_coordinates; std::vector<double> ws_temperature; std::vector<double> ws_thermalCond; std::vector<double> ws_density; std::vector<double> ws_specificHeat; // master element std::vector<double> ws_face_shape_function; std::vector<double> ws_dndx; std::vector<double> ws_det_j; // array for face nodes and nodes off face std::vector<double> ws_nodesOnFace; std::vector<double> ws_nodesOffFace; // define vector of parent topos; should always be UNITY in size std::vector<stk::topology> parentTopo; // define some common selectors stk::mesh::Selector s_locally_owned_union = meta_data.locally_owned_part() &stk::mesh::selectUnion(partVec_); stk::mesh::BucketVector const& face_buckets = realm_.get_buckets( meta_data.side_rank(), s_locally_owned_union ); for ( stk::mesh::BucketVector::const_iterator ib = face_buckets.begin(); ib != face_buckets.end() ; ++ib ) { stk::mesh::Bucket & b = **ib ; // extract connected element topology b.parent_topology(stk::topology::ELEMENT_RANK, parentTopo); ThrowAssert ( parentTopo.size() == 1 ); stk::topology theElemTopo = parentTopo[0]; MasterElement *meSCS = sierra::nalu::MasterElementRepo::get_surface_master_element(theElemTopo); const int nodesPerElement = meSCS->nodesPerElement_; // face master element MasterElement *meFC = sierra::nalu::MasterElementRepo::get_surface_master_element(b.topology()); const int nodesPerFace = meFC->nodesPerElement_; const int numScsBip = meFC->numIntPoints_; // algorithm related; element ws_coordinates.resize(nodesPerElement*nDim); ws_temperature.resize(nodesPerElement); ws_thermalCond.resize(nodesPerFace); ws_density.resize(nodesPerFace); ws_specificHeat.resize(nodesPerFace); ws_face_shape_function.resize(numScsBip*nodesPerFace); ws_dndx.resize(nDim*numScsBip*nodesPerElement); ws_det_j.resize(numScsBip); ws_nodesOnFace.resize(nodesPerElement); ws_nodesOffFace.resize(nodesPerElement); // pointers double *p_coordinates = &ws_coordinates[0]; double *p_temperature = &ws_temperature[0]; double *p_thermalCond = &ws_thermalCond[0]; double *p_density = &ws_density[0]; double *p_specificHeat = &ws_specificHeat[0]; double *p_face_shape_function = &ws_face_shape_function[0]; double *p_dndx = &ws_dndx[0]; double *p_nodesOnFace = &ws_nodesOnFace[0]; double *p_nodesOffFace = &ws_nodesOffFace[0]; // shape function meFC->shape_fcn(&p_face_shape_function[0]); const stk::mesh::Bucket::size_type length = b.size(); for ( stk::mesh::Bucket::size_type k = 0 ; k < length ; ++k ) { // get face stk::mesh::Entity face = b[k]; // pointer to face data const double * areaVec = stk::mesh::field_data(*exposedAreaVec_, b, k); //====================================== // gather nodal data off of face //====================================== stk::mesh::Entity const * face_node_rels = bulk_data.begin_nodes(face); const int num_face_nodes = bulk_data.num_nodes(face); // sanity check on num nodes ThrowAssert( num_face_nodes == nodesPerFace ); for ( int ni = 0; ni < num_face_nodes; ++ni ) { stk::mesh::Entity node = face_node_rels[ni]; // gather scalars p_density[ni] = *stk::mesh::field_data(*density_, node); const double lambda = *stk::mesh::field_data(*thermalCond_, node); const double Cp = *stk::mesh::field_data(*specificHeat_, node); p_specificHeat[ni] = Cp; p_thermalCond[ni] = lambda; } // extract the connected element to this exposed face; should be single in size! stk::mesh::Entity const * face_elem_rels = b.begin_elements(k); ThrowAssert( b.num_elements(k) == 1 ); // get element; its face ordinal stk::mesh::Entity element = face_elem_rels[0]; const int face_ordinal = b.begin_element_ordinals(k)[0]; // mapping from ip to nodes for this ordinal; element perspective (use with elem_node_relations) const int *ipNodeMap = meSCS->ipNodeMap(face_ordinal); //========================================== // gather nodal data off of element //========================================== stk::mesh::Entity const * elem_node_rels = bulk_data.begin_nodes(element); int num_nodes = bulk_data.num_nodes(element); // sanity check on num nodes ThrowAssert( num_nodes == nodesPerElement ); for ( int ni = 0; ni < num_nodes; ++ni ) { // sneak in nodesOn/offFace p_nodesOnFace[ni] = 0.0; p_nodesOffFace[ni] = 1.0; stk::mesh::Entity node = elem_node_rels[ni]; // gather scalars p_temperature[ni] = *stk::mesh::field_data(*temperature_, node); // gather vectors double * coords = stk::mesh::field_data(*coordinates_, node); const int offSet = ni*nDim; for ( int j=0; j < nDim; ++j ) { p_coordinates[offSet+j] = coords[j]; } } // process on/off while looping over face nodes for ( int ip = 0; ip < numScsBip; ++ip ) { const int nearestNode = ipNodeMap[ip]; p_nodesOnFace[nearestNode] = 1.0; p_nodesOffFace[nearestNode] = 0.0; } // compute dndx double scs_error = 0.0; meSCS->face_grad_op(1, face_ordinal, &p_coordinates[0], &p_dndx[0], &ws_det_j[0], &scs_error); // loop over boundary ips for ( int ip = 0; ip < numScsBip; ++ip ) { const int nearestNode = ipNodeMap[ip]; stk::mesh::Entity nodeR = elem_node_rels[nearestNode]; // pointers to nearest node data double *assembledWallArea = stk::mesh::field_data(*assembledWallArea_, nodeR); double *referenceTemperature = stk::mesh::field_data(*referenceTemperature_, nodeR); double *heatTransferCoefficient = stk::mesh::field_data(*heatTransferCoefficient_, nodeR); double *normalHeatFlux = stk::mesh::field_data(*normalHeatFlux_, nodeR); double *robinCouplingParameter = stk::mesh::field_data(*robinCouplingParameter_, nodeR); // offset for bip area vector and types of shape function const int faceOffSet = ip*nDim; const int offSetSF_face = ip*nodesPerFace; // interpolate to bip double thermalCondBip = 0.0; double densityBip = 0.0; double specificHeatBip = 0.0; for ( int ic = 0; ic < nodesPerFace; ++ic ) { const double r = p_face_shape_function[offSetSF_face+ic]; thermalCondBip += r*p_thermalCond[ic]; densityBip += r*p_density[ic]; specificHeatBip += r*p_specificHeat[ic]; } // handle flux due to on and off face in a single loop (on/off provided above) double dndx = 0.0; double dndxOn = 0.0; double dndxOff = 0.0; double invEltLen = 0.0; for ( int ic = 0; ic < nodesPerElement; ++ic ) { const int offSetDnDx = nDim*nodesPerElement*ip + ic*nDim; const double nodesOnFace = p_nodesOnFace[ic]; const double nodesOffFace = p_nodesOffFace[ic]; const double tempIC = p_temperature[ic]; for ( int j = 0; j < nDim; ++j ) { const double axj = areaVec[faceOffSet+j]; const double dndxj = p_dndx[offSetDnDx+j]; const double dTdA = dndxj*axj*tempIC; dndx += dTdA; dndxOn += dTdA*nodesOnFace; dndxOff += dTdA*nodesOffFace; invEltLen += dndxj*axj*nodesOnFace; } } // compute assembled area double aMag = 0.0; for ( int j = 0; j < nDim; ++j ) { const double axj = areaVec[faceOffSet+j]; aMag += axj*axj; } aMag = std::sqrt(aMag); double eltLen = aMag/invEltLen; // compute coupling parameter const double chi = densityBip * specificHeatBip * eltLen * eltLen / (2 * thermalCondBip * dt); const double alpha = compute_coupling_parameter(thermalCondBip, eltLen, chi); // assemble the nodal quantities *assembledWallArea += aMag; *normalHeatFlux -= thermalCondBip*dndx; *referenceTemperature -= thermalCondBip*dndxOff; *heatTransferCoefficient -= thermalCondBip*dndxOn; *robinCouplingParameter += alpha*aMag; } } } }