Changeset e85cfd
- Timestamp:
- Apr 9, 2013, 9:45:13 AM (13 years ago)
- Children:
- 0bd47e
- Parents:
- 4a709e
- Files:
-
- 11 edited
-
src/base/interface.cpp (modified) (2 diffs)
-
src/base/interface.hpp (modified) (3 diffs)
-
src/comm/mpi/settings.cpp (modified) (9 diffs)
-
src/grid/grid_index_translations.cpp (modified) (6 diffs)
-
src/grid/tempgrid.cpp (modified) (2 diffs)
-
src/solver/givens.hpp (modified) (2 diffs)
-
src/units/particle/interface_fcs.cpp (modified) (4 diffs)
-
src/units/particle/interface_particles.cpp (modified) (1 diff)
-
src/units/particle/interface_particles.hpp (modified) (1 diff)
-
test/interfaces/interface_sinus.hpp (modified) (1 diff)
-
test/unit_test/library/periodic_cs_mpi.cpp (modified) (1 diff)
Legend:
- Unmodified
- Added
- Removed
-
src/base/interface.cpp
r4a709e re85cfd 38 38 using namespace VMG; 39 39 40 static Index GetGlobalIndex(const Vector& pos, const SpatialExtent& extent, const BT& bt) 40 void Interface::InitInterface(const Vector& box_offset, const vmg_float& box_size, 41 const int& max_boundary_nodes, const vmg_float& alpha) 41 42 { 42 const Index index = (pos - extent.Begin()) / extent.MeshWidth() + 0.5;43 return index + (bt == LocallyRefined ? 1 : 0);44 }45 46 void Interface::InitInterface(const Vector& box_offset, const vmg_float& box_size,47 const int& coarseningSteps, const vmg_float& alpha)48 {49 int i;50 43 Index num_cells, size_factor; 51 Index add_node = Index(bc[0]==Periodic ?0:1,52 bc[1]==Periodic?0:1,53 bc[2]==Periodic?0:1);44 Index add_node = Index(bc[0]==Periodic ? 0 : 1, 45 bc[1]==Periodic ? 0 : 1, 46 bc[2]==Periodic ? 0 : 1); 54 47 55 48 const Vector box_center = box_offset + 0.5 * box_size; … … 58 51 * Get Extents 59 52 */ 60 for (i=0; i<coarseningSteps; ++i) {53 if (bc[0] == Open || bc[1] == Open || bc[2] == Open) { 61 54 62 for (int j=0; j<3; ++j) 63 size_factor[j] = (bc[j] == Open ? Helper::intpow(2, static_cast<int>(log(pow(alpha, i+1)) / log(2.0) + 1.0)) : 1); 55 while (global.size() == 0 || 56 (bc[0] == Open && global.back().GlobalSizeNew()[0] > max_boundary_nodes) || 57 (bc[1] == Open && global.back().GlobalSizeNew()[1] > max_boundary_nodes) || 58 (bc[2] == Open && global.back().GlobalSizeNew()[2] > max_boundary_nodes)) { 64 59 65 num_cells = Helper::intpow(2,levelMax-i) * size_factor; 60 global.push_back(GlobalIndices()); 61 extent.push_back(SpatialExtent()); 66 62 67 global.push_back(GlobalIndices());68 extent.push_back(SpatialExtent());63 for (int j=0; j<3; ++j) 64 size_factor[j] = (bc[j] == Open ? Helper::intpow(2, static_cast<int>(log(pow(alpha, global.size())) / log(2.0) + 1.0)) : 1); 69 65 70 extent.back().Size() = box_size * static_cast<Vector>(size_factor); 71 extent.back().Begin() = box_center - 0.5 * extent.back().Size(); 72 extent.back().End() = extent.back().Begin() + extent.back().Size(); 73 extent.back().MeshWidth() = extent.back().Size() / num_cells; 66 num_cells = Helper::intpow(2,levelMax-global.size()+1) * size_factor; 74 67 75 global.back().LocalSize() = num_cells + add_node; 76 global.back().LocalBegin() = -1 * num_cells / 2; 77 global.back().LocalEnd() = num_cells/2 + add_node; 68 extent.back().Size() = box_size * static_cast<Vector>(size_factor); 69 extent.back().Begin() = box_center - 0.5 * extent.back().Size(); 70 extent.back().End() = extent.back().Begin() + extent.back().Size(); 71 extent.back().MeshWidth() = extent.back().Size() / num_cells; 78 72 79 global.back().GlobalSizeNew() = global.back().LocalSize();80 global.back().GlobalBegin() = global.back().LocalBegin();81 global.back().GlobalEnd() = global.back().LocalEnd();73 global.back().LocalSize() = num_cells + add_node; 74 global.back().LocalBegin() = -1 * num_cells / 2; 75 global.back().LocalEnd() = num_cells/2 + add_node; 82 76 83 global.back().GlobalSizeFinest() = Helper::intpow(2, coarseningSteps)*num_cells + add_node;84 global.back().GlobalBeginFinest() = -1 * ((Helper::intpow(2, coarseningSteps)*num_cells) / 2);85 global.back().GlobalEndFinest() = (Helper::intpow(2, coarseningSteps)*num_cells) / 2 + add_node;77 global.back().GlobalSizeNew() = global.back().LocalSize(); 78 global.back().GlobalBegin() = global.back().LocalBegin(); 79 global.back().GlobalEnd() = global.back().LocalEnd(); 86 80 87 } 81 global.back().GlobalSizeFinest() = Helper::intpow(2, global.size()-1)*num_cells + add_node; 82 global.back().GlobalBeginFinest() = -1 * ((Helper::intpow(2, global.size()-1)*num_cells) / 2); 83 global.back().GlobalEndFinest() = (Helper::intpow(2, global.size()-1)*num_cells) / 2 + add_node; 88 84 89 if (coarseningSteps == 0) {85 global.back().BoundaryType() = LocallyRefined; 90 86 91 num_cells = Helper::intpow(2, levelMax); 87 } 92 88 93 global.push_back(GlobalIndices()); 94 extent.push_back(SpatialExtent()); 89 for (int i=global.size()-1; i>0; --i) { 90 if (global[i].GlobalSizeFinest().Max() > global[i-1].GlobalSizeFinest().Max()) { 91 global[i].BoundaryType() = GlobalMax; 92 break; 93 }else { 94 global[i].BoundaryType() = GlobalCoarsened; 95 } 96 } 97 } else { 95 98 96 extent.back().Size() = box_size; 97 extent.back().Begin() = box_center - 0.5 * extent.back().Size(); 98 extent.back().End() = extent.back().Begin() + extent.back().Size(); 99 extent.back().MeshWidth() = extent.back().Size() / num_cells; 99 num_cells = Helper::intpow(2, levelMax); 100 100 101 global.back().LocalSize() = num_cells + add_node; 102 global.back().LocalBegin() = -1 * num_cells/2; 103 global.back().LocalEnd() = num_cells/2 + add_node; 101 global.push_back(GlobalIndices()); 102 extent.push_back(SpatialExtent()); 104 103 105 global.back().GlobalSizeNew() = global.back().LocalSize(); 106 global.back().GlobalBegin() = global.back().LocalBegin(); 107 global.back().GlobalEnd() = global.back().LocalEnd(); 104 extent.back().Size() = box_size; 105 extent.back().Begin() = box_center - 0.5 * extent.back().Size(); 106 extent.back().End() = extent.back().Begin() + extent.back().Size(); 107 extent.back().MeshWidth() = extent.back().Size() / num_cells; 108 108 109 global.back().GlobalSizeFinest() = global.back().LocalSize();110 global.back().GlobalBeginFinest() = global.back().LocalBegin();111 global.back().GlobalEndFinest() = global.back().LocalEnd();109 global.back().LocalSize() = num_cells + add_node; 110 global.back().LocalBegin() = -1 * num_cells/2; 111 global.back().LocalEnd() = num_cells/2 + add_node; 112 112 113 } 113 global.back().GlobalSizeNew() = global.back().LocalSize(); 114 global.back().GlobalBegin() = global.back().LocalBegin(); 115 global.back().GlobalEnd() = global.back().LocalEnd(); 114 116 115 while (global.back().LocalSize().Min() > Helper::intpow(2, levelMin)+1) { 117 global.back().GlobalSizeFinest() = global.back().LocalSize(); 118 global.back().GlobalBeginFinest() = global.back().LocalBegin(); 119 global.back().GlobalEndFinest() = global.back().LocalEnd(); 116 120 117 num_cells /= 2;121 global.back().BoundaryType() = GlobalMax; 118 122 119 extent.back().Size() = (++extent.rbegin())->Size(); 120 extent.back().Begin() = (++extent.rbegin())->Begin(); 121 extent.back().End() = (++extent.rbegin())->End(); 122 extent.back().MeshWidth() = 2.0 * (++extent.rbegin())->MeshWidth(); 123 } 123 124 124 global.back().LocalSize() = num_cells + add_node;125 global.back().LocalBegin() = -1 * num_cells/2;126 global.back().LocalEnd() = num_cells/2 + add_node;127 125 128 global.back().GlobalSizeNew() = global.back().LocalSize(); 129 global.back().GlobalBegin() = global.back().LocalBegin(); 130 global.back().GlobalEnd() = global.back().LocalEnd(); 126 while (global.back().GlobalSizeNew().Min() > Helper::intpow(2, levelMin)+1) { 131 127 132 global.back().GlobalSizeFinest() = (++global.rbegin())->GlobalSizeFinest(); 133 global.back().GlobalBeginFinest() = (++global.rbegin())->GlobalBeginFinest(); 134 global.back().GlobalEndFinest() = (++global.rbegin())->GlobalEndFinest(); 135 } 128 num_cells /= 2; 136 129 137 for (i=global.size()-2; i>=0; --i) { 138 if (global[i].GlobalSizeFinest().Product() >= global[i+1].GlobalSizeFinest().Product()) { 139 global[i].BoundaryType() = GlobalCoarsened; 140 }else { 141 global[i].BoundaryType() = LocallyRefined; 142 global[i+1].BoundaryType() = GlobalMax; 143 break; 144 } 145 } 130 global.push_back(GlobalIndices()); 131 extent.push_back(SpatialExtent()); 146 132 147 levelMin = levelMax - global.size() + 1; 133 extent.back().Size() = (++extent.rbegin())->Size(); 134 extent.back().Begin() = (++extent.rbegin())->Begin(); 135 extent.back().End() = (++extent.rbegin())->End(); 136 extent.back().MeshWidth() = 2.0 * (++extent.rbegin())->MeshWidth(); 137 138 global.back().LocalSize() = num_cells + add_node; 139 global.back().LocalBegin() = -1 * num_cells/2; 140 global.back().LocalEnd() = num_cells/2 + add_node; 141 142 global.back().GlobalSizeNew() = global.back().LocalSize(); 143 global.back().GlobalBegin() = global.back().LocalBegin(); 144 global.back().GlobalEnd() = global.back().LocalEnd(); 145 146 global.back().GlobalSizeFinest() = (++global.rbegin())->GlobalSizeFinest(); 147 global.back().GlobalBeginFinest() = (++global.rbegin())->GlobalBeginFinest(); 148 global.back().GlobalEndFinest() = (++global.rbegin())->GlobalEndFinest(); 149 150 global.back().BoundaryType() = GlobalCoarsened; 151 152 } 153 154 levelMin = levelMax - global.size() + 1; 148 155 } -
src/base/interface.hpp
r4a709e re85cfd 45 45 Interface(const Boundary& boundary, const int& levelMin, const int& levelMax, 46 46 const Vector& box_offset, const vmg_float box_size, 47 int coarseningSteps=0, vmg_float alpha=1.6,47 int max_boundary_nodes=9, vmg_float alpha=1.6, 48 48 bool register_ = true) : 49 49 Object("INTERFACE", register_), … … 52 52 levelMax(levelMax) 53 53 { 54 InitInterface(box_offset, box_size, coarseningSteps, alpha);54 InitInterface(box_offset, box_size, max_boundary_nodes, alpha); 55 55 } 56 56 … … 80 80 private: 81 81 void InitInterface(const Vector& box_offset, const vmg_float& box_end, 82 const int& coarseningSteps, const vmg_float& alpha);82 const int& max_boundary_nodes, const vmg_float& alpha); 83 83 84 84 std::vector<GlobalIndices> global; -
src/comm/mpi/settings.cpp
r4a709e re85cfd 96 96 97 97 if (temp_grid->Global().LocalBegin().IsComponentwiseGreaterOrEqual(sol(i-1).Global().LocalBegin()) && 98 temp_grid->Global().LocalBegin().IsComponentwiseLessOrEqual(sol(i-1).Global().LocalEnd()) &&99 temp_grid->Global().LocalEnd().IsComponentwiseGreaterOrEqual(sol(i-1).Global().LocalBegin()) &&100 98 temp_grid->Global().LocalEnd().IsComponentwiseLessOrEqual(sol(i-1).Global().LocalEnd())) { 101 99 delete temp_grid; … … 107 105 } 108 106 107 //FIXME 109 108 for (int i=rhs.MaxLevel(); i>rhs.MinLevel(); --i) { 110 109 … … 112 111 temp_grid->SetPropertiesToCoarser(rhs(i), comm.BoundaryConditions()); 113 112 114 if (temp_grid->Global().LocalBegin().IsComponentwiseGreaterOrEqual(sol(i-1).Global().LocalBegin()) && 115 temp_grid->Global().LocalBegin().IsComponentwiseLessOrEqual(sol(i-1).Global().LocalEnd()) && 116 temp_grid->Global().LocalEnd().IsComponentwiseGreaterOrEqual(sol(i-1).Global().LocalBegin()) && 117 temp_grid->Global().LocalEnd().IsComponentwiseLessOrEqual(sol(i-1).Global().LocalEnd())) { 113 if (temp_grid->Global().LocalBegin().IsComponentwiseGreaterOrEqual(rhs(i-1).Global().LocalBegin()) && 114 temp_grid->Global().LocalEnd().IsComponentwiseLessOrEqual(rhs(i-1).Global().LocalEnd())) { 118 115 delete temp_grid; 119 116 coarser_grids.insert(std::make_pair(&rhs(i), &rhs(i-1))); … … 132 129 temp_grid->SetPropertiesToFiner(sol(i), comm.BoundaryConditions()); 133 130 134 if (temp_grid->Global().LocalBegin() == sol(i+1).Global().LocalBegin() &&135 temp_grid->Global().LocalEnd() == sol(i+1).Global().LocalEnd()) {131 if (temp_grid->Global().LocalBegin().IsComponentwiseGreaterOrEqual(sol(i+1).Global().LocalBegin()) && 132 temp_grid->Global().LocalEnd().IsComponentwiseLessOrEqual(sol(i+1).Global().LocalEnd())) { 136 133 delete temp_grid; 137 134 finer_grids.insert(std::make_pair(&sol(i), &sol(i+1))); … … 147 144 temp_grid->SetPropertiesToFiner(rhs(i), comm.BoundaryConditions()); 148 145 149 if (temp_grid->Global().LocalBegin() == rhs(i+1).Global().LocalBegin() &&150 temp_grid->Global().LocalEnd() == rhs(i+1).Global().LocalEnd()) {146 if (temp_grid->Global().LocalBegin().IsComponentwiseGreaterOrEqual(rhs(i+1).Global().LocalBegin()) && 147 temp_grid->Global().LocalEnd().IsComponentwiseLessOrEqual(rhs(i+1).Global().LocalEnd())) { 151 148 delete temp_grid; 152 149 finer_grids.insert(std::make_pair(&rhs(i), &rhs(i+1))); … … 281 278 { 282 279 MPI_Comm comm = CommunicatorGlobal(grid_old); 283 bool dt_is_new = true;284 280 285 281 // Insert into map … … 287 283 datatypes_global.insert(std::make_pair(VMG::MPI::KeyUnsorted(grid_old, grid_new, direction), VMG::MPI::DatatypesGlobal())); 288 284 VMG::MPI::DatatypesGlobal& dt_global = insert_result.first->second; 289 dt_is_new = insert_result.second;285 bool dt_is_new = insert_result.second; 290 286 291 287 … … 336 332 dt_global.Receive().push_back(VMG::MPI::Datatype(grid_new.Local().SizeTotal(), 337 333 end - begin, 338 begin - grid_new.Global().LocalBegin() + grid_new.Global().GlobalBegin() +offset_new,334 begin - grid_new.Global().LocalBegin() + offset_new, 339 335 i, 0, 0, true)); 340 336 } … … 370 366 dt_global.Send().push_back(VMG::MPI::Datatype(grid_old.Local().SizeTotal(), 371 367 end - begin, 372 begin - grid_old.Global().LocalBegin() + grid_old.Global().GlobalBegin() +offset_old,368 begin - grid_old.Global().LocalBegin() + offset_old, 373 369 i, 0, 0, true)); 374 370 } -
src/grid/grid_index_translations.cpp
r4a709e re85cfd 36 36 #include "grid/grid.hpp" 37 37 #include "grid/multigrid.hpp" 38 #include "mg.hpp" 38 39 39 40 using namespace VMG; … … 41 42 bool GridIndexTranslations::IsGridPointOf(const Grid& grid, const Index& index_finest) 42 43 { 43 assert(grid.Father() != NULL);44 return index_finest[0] % Helper::intpow(2, grid.Father()->MaxLevel()- grid.Level()) == 0 &&45 index_finest[1] % Helper::intpow(2, grid.Father()->MaxLevel()- grid.Level()) == 0 &&46 index_finest[2] % Helper::intpow(2, grid.Father()->MaxLevel()- grid.Level()) == 0;44 const int max_level = MG::GetSol()->MaxLevel(); 45 return index_finest[0] % Helper::intpow(2, max_level - grid.Level()) == 0 && 46 index_finest[1] % Helper::intpow(2, max_level - grid.Level()) == 0 && 47 index_finest[2] % Helper::intpow(2, max_level - grid.Level()) == 0; 47 48 } 48 49 … … 64 65 Index GridIndexTranslations::GlobalToGlobalFinest(const Grid& grid, const Index& index_global) 65 66 { 66 assert(grid.Father() != NULL); 67 return Helper::intpow(2, grid.Father()->MaxLevel() - grid.Level()) * index_global; 67 return Helper::intpow(2, MG::GetSol()->MaxLevel() - grid.Level()) * index_global; 68 68 } 69 69 … … 75 75 Index GridIndexTranslations::GlobalFinestToGlobal(const Grid& grid, const Index& index_finest) 76 76 { 77 assert(grid.Father() != NULL);78 77 assert(IsGridPointOf(grid, index_finest)); 79 return index_finest / Helper::intpow(2, grid.Father()->MaxLevel() - grid.Level());78 return index_finest / Helper::intpow(2, MG::GetSol()->MaxLevel() - grid.Level()); 80 79 } 81 80 … … 97 96 98 97 void GridIndexTranslations::GetGridAlignment(const Grid& grid_1, GridIteratorSet& bounds_1, 99 const Grid& grid_2, GridIteratorSet& bounds_2)98 const Grid& grid_2, GridIteratorSet& bounds_2) 100 99 { 101 assert(grid_1.Father() != NULL);102 assert(grid_2.Father() != NULL);103 104 100 if (grid_1.Level() == grid_2.Level()) { 105 101 const Index begin_global = grid_1.Global() … … 117 113 118 114 const Grid& grid_c = (grid_1.Level() < grid_2.Level() ? grid_1 : grid_2); 119 const int global_mult = Helper::intpow(2, grid_c.Father()->MaxLevel() - grid_c.Level());115 const int global_mult = Helper::intpow(2, MG::GetSol()->MaxLevel() - grid_c.Level()); 120 116 121 117 Index begin_finest = GlobalToGlobalFinest(grid_1, grid_1.Global().LocalBegin()) -
src/grid/tempgrid.cpp
r4a709e re85cfd 104 104 105 105 const Grid& grid_finer = (*grid.Father())(grid.Level()+1); 106 const Index off = GridIndexTranslations::EndOffset(boundary);107 106 108 107 /* … … 123 122 124 123 global.LocalBegin() = (2*grid.Global().LocalBegin()).Clamp(global.GlobalBegin(), global.GlobalEnd()); 125 global.LocalEnd() = (2* (grid.Global().LocalEnd()-off)+off).Clamp(global.GlobalBegin(), global.GlobalEnd());124 global.LocalEnd() = (2*grid.Global().LocalEnd()).Clamp(global.GlobalBegin(), global.GlobalEnd()); 126 125 global.LocalSize() = global.LocalEnd() - global.LocalBegin(); 127 126 -
src/solver/givens.hpp
r4a709e re85cfd 42 42 public: 43 43 Givens(bool register_ = true) : 44 T(register_)45 {}44 T(register_) 45 {} 46 46 47 47 Givens(int size, bool register_ = true) : 48 T(size, register_)48 T(size, register_) 49 49 {} 50 50 … … 63 63 if (fabs(this->Mat(j,i)) > DBL_EPSILON) { 64 64 65 t = 1.0 / sqrt(this->Mat(i,i)*this->Mat(i,i) + this->Mat(j,i)*this->Mat(j,i));66 s = t * this->Mat(j,i);67 c = t * this->Mat(i,i);65 t = 1.0 / sqrt(this->Mat(i,i)*this->Mat(i,i) + this->Mat(j,i)*this->Mat(j,i)); 66 s = t * this->Mat(j,i); 67 c = t * this->Mat(i,i); 68 68 69 for (int k=i; k<n; k++) {69 for (int k=i; k<n; k++) { 70 70 71 t = c * this->Mat(i,k) + s * this->Mat(j,k);71 t = c * this->Mat(i,k) + s * this->Mat(j,k); 72 72 73 if (k != i)74 this->Mat(j,k) = c * this->Mat(j,k) - s * this->Mat(i,k);73 if (k != i) 74 this->Mat(j,k) = c * this->Mat(j,k) - s * this->Mat(i,k); 75 75 76 this->Mat(i,k) = t;76 this->Mat(i,k) = t; 77 77 78 }78 } 79 79 80 t = c * this->Rhs(i) + s * this->Rhs(j);80 t = c * this->Rhs(i) + s * this->Rhs(j); 81 81 82 this->Rhs(j) = c * this->Rhs(j) - s * this->Rhs(i);82 this->Rhs(j) = c * this->Rhs(j) - s * this->Rhs(i); 83 83 84 this->Rhs(i) = t;84 this->Rhs(i) = t; 85 85 86 this->Mat(j,i) = 0.0;86 this->Mat(j,i) = 0.0; 87 87 88 88 } -
src/units/particle/interface_fcs.cpp
r4a709e re85cfd 63 63 64 64 #include "cycles/cycle_cs_periodic_debug.hpp" 65 65 //TODO: Remove Debug 66 66 67 67 using namespace VMG; … … 112 112 periodic[2] ? Periodic : Open); 113 113 114 const bool singular = periodic[0] * periodic[1] * periodic[2]; 114 const bool singular = boundary[0] == Periodic && 115 boundary[1] == Periodic && 116 boundary[2] == Periodic; 115 117 116 118 /* … … 121 123 new Particle::CommMPI(boundary, new DomainDecompositionMPI(), mpi_comm); 122 124 new DiscretizationPoissonFD(discretization_order); 123 new InterfaceParticles(boundary, 2, level, Vector(box_offset), box_size, near_field_cells , 0, 1.0);125 new InterfaceParticles(boundary, 2, level, Vector(box_offset), box_size, near_field_cells); 124 126 new LevelOperatorCS(Stencils::RestrictionFullWeight, Stencils::InterpolationTrilinear); 125 127 new Givens<SolverSingular>(); 126 new CycleCSPeriodic Debug(cycle_type);128 new CycleCSPeriodic(cycle_type); 127 129 128 130 }else { … … 130 132 new Particle::CommMPI(boundary, new DomainDecompositionMPI(), mpi_comm); 131 133 new DiscretizationPoissonFV(discretization_order); 132 new InterfaceParticles(boundary, 2, level, Vector(box_offset), box_size, near_field_cells, 2, 1.6);134 new InterfaceParticles(boundary, 2, level, Vector(box_offset), box_size, near_field_cells, 9, 1.6); 133 135 new LevelOperatorFAS(Stencils::RestrictionFullWeight, Stencils::Injection, Stencils::InterpolationTrilinear); 134 136 new Givens<SolverRegular>(); -
src/units/particle/interface_particles.cpp
r4a709e re85cfd 233 233 const vmg_int& num_particles_local = factory.GetObjectStorageVal<vmg_int>("PARTICLE_NUM_LOCAL"); 234 234 const vmg_float* p = factory.GetObjectStorageArray<vmg_float>("PARTICLE_POTENTIAL_ARRAY"); 235 const vmg_float* f = factory.GetObjectStorageArray<vmg_float>("PARTICLE_FIELD_ARRAY");236 235 237 236 -
src/units/particle/interface_particles.hpp
r4a709e re85cfd 49 49 const Vector& box_offset, const vmg_float& box_size, 50 50 const int& near_field_cells, 51 const int& coarsening_steps, const vmg_float& alpha) :52 Interface(boundary, levelMin, levelMax, box_offset, box_size, coarsening_steps, alpha),51 const int& max_boundary_nodes = 9, const vmg_float& alpha = 1.6) : 52 Interface(boundary, levelMin, levelMax, box_offset, box_size, max_boundary_nodes, alpha), 53 53 spl(near_field_cells, Extent(MaxLevel()).MeshWidth().Max()) 54 54 {} -
test/interfaces/interface_sinus.hpp
r4a709e re85cfd 44 44 VMG::Boundary boundary, int levelMin, int levelMax, 45 45 vmg_float box_begin, vmg_float box_end, 46 int coarseningSteps=0, double alpha=1.6) :46 int max_boundary_nodes=9, double alpha=1.6) : 47 47 VMG::Interface(boundary, levelMin, levelMax, 48 box_begin, box_end, coarseningSteps, alpha),48 box_begin, box_end, max_boundary_nodes, alpha), 49 49 sine_factor(sine_factor) 50 50 {} -
test/unit_test/library/periodic_cs_mpi.cpp
r4a709e re85cfd 44 44 #include "comm/domain_decomposition_mpi.hpp" 45 45 #include "cycles/cycle_cs_periodic.hpp" 46 #include "cycles/cycle_cs_periodic_debug.hpp" 46 47 #include "level/level_operator_cs.hpp" 47 48 #include "samples/discretization_poisson_fd.hpp"
Note:
See TracChangeset
for help on using the changeset viewer.
