374 void randSeed(
int p) { m_randSeed = ((0 <= p) ? p : 1); }
381 return m_edgeLengthMeasurement;
386 m_edgeLengthMeasurement =
elm;
438 void minDistCC(
double x) { m_minDistCC = ((x > 0) ? x : 1); }
498 return m_initialPlacementMult;
503 m_initialPlacementMult =
ipm;
531 return m_repulsiveForcesCalculation;
536 m_repulsiveForcesCalculation =
rfc;
553 void threshold(
double x) { m_threshold = ((x > 0) ? x : 0.1); }
585 void coolValue(
double x) { m_coolValue = (((x > 0) && (x <= 1)) ? x : 0.99); }
589 return m_initialPlacementForces;
594 m_initialPlacementForces =
ipf;
681 m_NMTreeConstruction =
rtc;
925 double scaling = 1.0;
928 double ratio = width / height;
929 if (ratio < pageRatio()) {
931 scaling = pageRatio() / ratio;
934 scaling = ratio / pageRatio();
937 return width * height * scaling;
1001 switch (repulsiveForcesCalculation()) {
1002 case FMMMOptions::RepulsiveForcesMethod::Exact:
1005 case FMMMOptions::RepulsiveForcesMethod::GridApproximation:
1008 case FMMMOptions::RepulsiveForcesMethod::NMM:
1016 if (repulsiveForcesCalculation() == FMMMOptions::RepulsiveForcesMethod::NMM) {
1076 double x_min = down_left_corner.
m_x;
1077 double x_max = down_left_corner.
m_x + boxlength;
1078 double y_min = down_left_corner.
m_y;
1079 double y_max = down_left_corner.
m_y + boxlength;
Declares ClusterGraphAttributes, an extension of class GraphAttributes, to store clustergraph layout ...
Includes declaration of graph class.
Declaration of interface for layout algorithms (class LayoutModule)
Declaration of class NewMultipoleMethod (NMM).
Declaration of classes GenericPoint, GenericPolyline, GenericLine, GenericSegment,...
Stores additional attributes of a clustered graph (like layout information).
Dynamic arrays indexed with edges.
The fast multipole multilevel layout algorithm.
void set_average_ideal_edgelength(Graph &G, EdgeArray< EdgeAttributes > &E)
The average_ideal_edgelength for all edges is computed.
DPoint down_left_corner
Holds down left corner of the comput.
int m_NMPrecision
The precision for multipole expansions.
void rotate_components_and_calculate_bounding_rectangles(List< Rectangle > &R, Graph G_sub[], NodeArray< NodeAttributes > A_sub[])
If number_of_components > 1, the subgraphs G_sub are rotated and skipped to find bounding rectangles ...
double cool_factor
Needed for scaling the forces if coolTemperature is true.
double getCpuTime()
Returns the runtime (=CPU-time) of the layout algorithm in seconds.
void init_F(Graph &G, NodeArray< DPoint > &F)
Sets all entries of F to (0,0).
void fineTuningIterations(int n)
Sets the number of iterations for fine tuning to n.
void fineTuneScalar(double s)
Sets the option fineTuneScalar to s.
void create_initial_placement_random(const Graph &G, NodeArray< NodeAttributes > &A)
Places nodes randomly.
FMMMOptions::SmallestCellFinding nmSmallCell() const
Returns the current setting of option nmSmallCell.
int number_of_components
The number of components of the graph.
double m_postStrengthOfRepForces
The strength of repulsive forces during postprocessing.
void call_POSTPROCESSING_step(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E, NodeArray< DPoint > &F, NodeArray< DPoint > &F_attr, NodeArray< DPoint > &F_rep, NodeArray< DPoint > &last_node_movement)
Calls the postprocessing step.
void call(GraphAttributes &GA, char *ps_file)
Extended algorithm call: Calls the algorithm for graph GA.
double f_attr_scalar(double d, double ind_ideal_edge_length)
Returns the attractive force scalar.
FMMMOptions::ForceModel forceModel() const
Returns the used force model.
FMMMOptions::EdgeLengthMeasurement m_edgeLengthMeasurement
The option for edge length measurement.
double m_pageRatio
The desired page ratio.
bool m_newInitialPlacement
The option for new initial placement.
void repulsiveForcesCalculation(FMMMOptions::RepulsiveForcesMethod rfc)
Sets the option repulsiveForcesCalculation to rfc.
bool m_adjustPostRepStrengthDynamically
The option adjustPostRepStrengthDynamically.
double m_minDistCC
The separation between connected components.
bool m_coolTemperature
The option for how to scale forces.
void initialPlacementMult(FMMMOptions::InitialPlacementMult ipm)
Sets the option initialPlacementMult to ipm.
int m_stepsForRotatingComponents
The number of rotations.
void stepsForRotatingComponents(int n)
Sets the option stepsForRotatingComponents to n.
NodeArray< double > radius
Holds the radius of the surrounding circle for each node.
energybased::fmmm::FruchtermanReingold FR
Class for repulsive force calculation (Fruchterman, Reingold).
double m_coolValue
The value by which forces are decreased.
void call(GraphAttributes &GA, const EdgeArray< double > &edgeLength)
Extended algorithm call: Allows to pass desired lengths of the edges.
FMMMOptions::ReducedTreeConstruction m_NMTreeConstruction
The option for how to construct reduced bucket quadtree.
bool m_singleLevel
Option for pure single level.
void qualityVersusSpeed(FMMMOptions::QualityVsSpeed qvs)
Sets the option qualityVersusSpeed to qvs.
int fixedIterations() const
Returns the fixed number of iterations for the stop criterion.
FMMMOptions::EdgeLengthMeasurement edgeLengthMeasurement() const
Returns the current setting of option edgeLengthMeasurement.
void create_postscript_drawing(GraphAttributes &GA, char *ps_file)
Creates a simple drawing of GA in postscript format and saves it in file ps_file.
bool m_resizeDrawing
The option for resizing the drawing.
void delete_parallel_edges(const Graph &G, EdgeArray< EdgeAttributes > &E, Graph &G_reduced, List< edge > &S, EdgeArray< double > &new_edgelength)
Deletes parallel edges of G_reduced.
void adapt_drawing_to_ideal_average_edgelength(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E)
If resizeDrawing is true, the drawing is adapted to the ideal average edge length by shrinking respec...
FMMMOptions::QualityVsSpeed m_qualityVersusSpeed
The option for quality-vs-speed trade-off.
bool running(int iter, int max_mult_iter, double actforcevectorlength)
Returns true iff stopCriterion() is not met.
double get_post_rep_force_strength(int n)
Returns the value for the strength of the repulsive forces.
void create_maximum_connected_subGraphs(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E, Graph G_sub[], NodeArray< NodeAttributes > A_sub[], EdgeArray< EdgeAttributes > E_sub[], NodeArray< int > &component)
Constructs the list of connected components of G.
FMMMOptions::PreSort presortCCs() const
Returns the current setting of option presortCCs.
int minGraphSize() const
Returns the current setting of option minGraphSize.
void move_nodes(Graph &G, NodeArray< NodeAttributes > &A, NodeArray< DPoint > &F)
Move the nodes.
double forceScalingFactor() const
Returns the scaling factor for the forces.
int m_fixedIterations
The fixed number of iterations for the stop criterion.
void restrict_force_to_comp_box(DPoint &force)
The force is restricted to have values within the comp.
void randomTries(int n)
Sets the option randomTries to n.
double m_fineTuneScalar
Parameter for scaling forces during fine tuning.
double average_ideal_edgelength
Measured from center to center.
FMMMOptions::InitialPlacementForces m_initialPlacementForces
The option for how the initial placement is done.
void make_initialisations_for_rep_calc_classes(Graph &G)
Make initializations for the data structures that are used in the choosen class for rep....
void coolTemperature(bool b)
Sets the option coolTemperature to b.
void import_NodeAttributes(const Graph &G, GraphAttributes &GA, NodeArray< NodeAttributes > &A)
Imports for each node v of G its width, height and position (given from GA) in A.
void forceModel(FMMMOptions::ForceModel fm)
Sets the used force model to fm.
FMMMOptions::MaxIterChange m_maxIterChange
The option for how to change MaxIterations. If maxIterChange != micConstant, the iterations are decre...
double resizingScalar() const
Returns the current setting of option resizingScalar.
FMMMOptions::GalaxyChoice m_galaxyChoice
The selection of galaxy nodes.
void repForcesStrength(double x)
Sets the strength of the repulsive forces to x.
FMMMOptions::AllowedPositions allowedPositions() const
Returns the current setting of option allowedPositions.
int maxIterFactor() const
Returns the current setting of option maxIterFactor.
double m_forceScalingFactor
The scaling factor for the forces.
void deallocate_memory_for_rep_calc_classes()
Deallocates dynamically allocated memory of the choosen rep. calculation class.
void init_time()
Sets time_total to zero.
void presortCCs(FMMMOptions::PreSort ps)
Sets the option presortCCs to ps.
void postSpringStrength(double x)
Sets the strength of the springs in the postprocessing step to x.
int get_max_mult_iter(int act_level, int max_level, int node_nr)
Returns the maximum number of iterations for the force calc.
int maxIntPosExponent() const
Returns the current setting of option maxIntPosExponent.
double pageRatio() const
Returns the current setting of option pageRatio.
void pack_subGraph_drawings(NodeArray< NodeAttributes > &A, Graph G_sub[], NodeArray< NodeAttributes > A_sub[])
The drawings of the subgraphs are packed.
int m_maxIntPosExponent
The option for the used exponent.
int m_NMParticlesInLeaves
The maximal number of particles in a leaf.
int nmParticlesInLeaves() const
Returns the current setting of option nmParticlesInLeaves.
FMMMOptions::InitialPlacementMult m_initialPlacementMult
The option for creating initial placement.
FMMMOptions::SmallestCellFinding m_NMSmallCell
The option for how to calculate smallest quadtratic cells.
void frGridQuotient(int p)
Sets the option frGridQuotient to p.
void init_ind_ideal_edgelength(const Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E)
Sets the individual ideal edge length for each edge e.
void pageFormat(FMMMOptions::PageFormatType t)
Sets the option pageRatio to t.
bool adjustPostRepStrengthDynamically() const
Returns the current setting of option adjustPostRepStrengthDynamically.
int m_randomTries
The number of random tries.
void import_EdgeAttributes(const Graph &G, const EdgeArray< double > &edgeLength, EdgeArray< EdgeAttributes > &E)
Imports for each edge e of G its desired length given via edgeLength.
FMMMOptions::QualityVsSpeed qualityVersusSpeed() const
Returns the current setting of option qualityVersusSpeed.
void nmParticlesInLeaves(int n)
Sets the option nmParticlesInLeaves to n.
double threshold() const
Returns the threshold for the stop criterion.
int m_fineTuningIterations
The number of iterations for fine tuning.
FMMMOptions::RepulsiveForcesMethod m_repulsiveForcesCalculation
Option for how to calculate repulsive forces.
void resetOptions()
All parameter options (both low- and high-level) are set to the default values.
bool coolTemperature() const
Returns the current setting of option coolTemperature.
void setSingleLevel(bool b)
Sets single level option, no multilevel hierarchy is created if b == true.
double springStrength() const
Returns the strength of the springs.
double max_radius(int iter)
Describes the max. radius of a move in one time step, depending on the number of iterations.
bool m_useHighLevelOptions
The option for using high-level options.
FMMMOptions::ReducedTreeConstruction nmTreeConstruction() const
Returns the current setting of option nmTreeConstruction.
FMMMOptions::InitialPlacementMult initialPlacementMult() const
Returns the current setting of option initialPlacementMult.
void tipOverCCs(FMMMOptions::TipOver to)
Sets the option tipOverCCs to to.
FMMMOptions::AllowedPositions m_allowedPositions
The option for allowed positions.
void calculate_attractive_forces(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E, NodeArray< DPoint > &F_attr)
Calculates attractive forces for each node.
void resizeDrawing(bool b)
Sets the option resizeDrawing to b.
int nmPrecision() const
Returns the precision p for the p-term multipole expansions.
void nmPrecision(int p)
Sets the precision for the multipole expansions to p.
double get_average_forcevector_length(Graph &G, NodeArray< DPoint > &F)
Calculates the average force on each node in the actual iteration, which is needed if StopCriterion i...
double unitEdgeLength() const
Returns the current setting of option unitEdgeLength.
energybased::fmmm::NewMultipoleMethod NM
Class for repulsive force calculation.
double postStrengthOfRepForces() const
Returns the strength of the repulsive forces in the postprocessing step.
void threshold(double x)
Sets the threshold for the stop criterion to x.
int stepsForRotatingComponents() const
Returns the current setting of option stepsForRotatingComponents.
void maxIterFactor(int f)
Sets the option maxIterFactor to f.
void make_simple_loopfree(const Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > E, Graph &G_reduced, NodeArray< NodeAttributes > &A_reduced, EdgeArray< EdgeAttributes > &E_reduced)
Creates a simple and loopfree copy of G and stores the corresponding node / edge attributes.
void resizingScalar(double s)
Sets the option resizingScalar to s.
FMMMOptions::PageFormatType m_pageFormat
The option for the page format.
void update_low_level_options_due_to_high_level_options_settings()
Updates several low level parameter options due to the settings of the high level parameter options.
void init_boxlength_and_cornercoordinate(Graph &G, NodeArray< NodeAttributes > &A)
The length of the computational box in the first iteration is set (down left corner is at (0,...
Rectangle calculate_bounding_rectangle(Graph &G, NodeArray< NodeAttributes > &A, int componenet_index)
The bounding rectangle of the componenet_index-th. component of G is returned.
void maxIterChange(FMMMOptions::MaxIterChange mic)
Sets the option maxIterChange to mic.
void randSeed(int p)
Sets the seed of the random number generator.
void edgeLengthMeasurement(FMMMOptions::EdgeLengthMeasurement elm)
Sets the option edgeLengthMeasurement to elm.
void pageRatio(double r)
Sets the option pageRatio to r.
FMMMOptions::StopCriterion stopCriterion() const
Returns the stop criterion.
void unitEdgeLength(double x)
Sets the option unitEdgeLength to x.
void forceScalingFactor(double f)
Sets the scaling factor for the forces to f.
int m_frGridQuotient
The grid quotient.
FMMMOptions::MaxIterChange maxIterChange() const
Returns the current setting of option maxIterChange.
double m_springStrength
The strengths of springs.
void initialPlacementForces(FMMMOptions::InitialPlacementForces ipf)
Sets the option initialPlacementForces to ipf.
void maxIntPosExponent(int e)
Sets the option maxIntPosExponent to e.
double m_repForcesStrength
The strength of repulsive forces.
int randSeed() const
Returns the seed of the random number generator.
FMMMOptions::GalaxyChoice galaxyChoice() const
Returns the current setting of option galaxyChoice.
void call_MULTILEVEL_step_for_subGraph(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E)
Calls the multilevel step for subGraph G.
void create_initial_placement(Graph &G, NodeArray< NodeAttributes > &A)
The initial placements of the nodes are created by using initialPlacementForces().
FMMMOptions::StopCriterion m_stopCriterion
The stop criterion.
double repForcesStrength() const
Returns the strength of the repulsive forces.
void calculate_bounding_rectangles_of_components(List< Rectangle > &R, Graph G_sub[], NodeArray< NodeAttributes > A_sub[])
The bounding rectangles of all connected componenents of G are calculated and stored in R.
void export_node_positions(NodeArray< NodeAttributes > &A, List< Rectangle > &R, Graph G_sub[], NodeArray< NodeAttributes > A_sub[])
The positions of the nodes in the subgraphs are calculated by using the information stored in R and a...
int frGridQuotient() const
Returns the current setting of option frGridQuotient.
FMMMLayout()
Creates an instance of the layout algorithm.
int m_minGraphSize
The option for minimal graph size.
void useHighLevelOptions(bool uho)
Sets the option useHighLevelOptions to uho.
void galaxyChoice(FMMMOptions::GalaxyChoice gc)
Sets the option galaxyChoice to gc.
void adjustPostRepStrengthDynamically(bool b)
Sets the option adjustPostRepStrengthDynamically to b.
bool resizeDrawing() const
Returns the current setting of option resizeDrawing.
double max_integer_position
The maximum value for an integer position.
void nmSmallCell(FMMMOptions::SmallestCellFinding scf)
Sets the option nmSmallCell to scf.
bool useHighLevelOptions() const
Returns the current setting of option useHighLevelOptions.
double m_resizingScalar
Parameter for resizing the drawing.
void stopCriterion(FMMMOptions::StopCriterion rsc)
Sets the stop criterion to rsc.
double fineTuneScalar() const
Returns the curent setting of option fineTuneScalar.
FMMMOptions::InitialPlacementForces initialPlacementForces() const
Returns the current setting of option initialPlacementForces.
void minDistCC(double x)
Sets the minimal distance between connected components to x.
void export_NodeAttributes(Graph &G_reduced, NodeArray< NodeAttributes > &A_reduced, GraphAttributes &GA)
Exports for each node v in G_reduced the position of the original_node in GA.
double boxlength
Holds the length of the quadratic comput.
double postSpringStrength() const
Returns the strength of the springs in the postprocessing step.
void delete_all_subGraphs(Graph G_sub[], NodeArray< NodeAttributes > A_sub[], EdgeArray< EdgeAttributes > E_sub[])
Frees dynamically allocated memory for the connected component subgraphs.
void coolValue(double x)
Sets the option coolValue to x.
void prevent_oscillations(Graph &G, NodeArray< DPoint > &F, NodeArray< DPoint > &last_node_movement, int iter)
Depending on the direction of last_node_movement[v], the length of the next displacement of node v is...
FMMMOptions::RepulsiveForcesMethod repulsiveForcesCalculation() const
Returns the current setting of option repulsiveForcesCalculation.
FMMMOptions::TipOver m_tipOverCCs
Option for tip-over of connected components.
FMMMOptions::PreSort m_presortCCs
The option for presorting connected components.
void adjust_positions(const Graph &G, NodeArray< NodeAttributes > &A)
Adjust positions according to allowedPositions()
double coolValue() const
Returns the current setting of option coolValue.
void fixedIterations(int n)
Sets the fixed number of iterations for the stop criterion to n.
void add_attr_rep_forces(Graph &G, NodeArray< DPoint > &F_attr, NodeArray< DPoint > &F_rep, NodeArray< DPoint > &F, int iter, int fine_tuning_step)
Add attractive and repulsive forces for each node.
int m_randSeed
The random seed.
virtual void call(GraphAttributes &GA) override
Calls the algorithm for graph GA and returns the layout information in GA.
void minGraphSize(int n)
Sets the option minGraphSize to n.
int fineTuningIterations() const
Returns the number of iterations for fine tuning.
void update_boxlength_and_cornercoordinate(Graph &G, NodeArray< NodeAttributes > &A)
Computes a new tight computational square-box.
int m_maxIterFactor
The factor used for decreasing MaxIterations.
void calculate_forces(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E, NodeArray< DPoint > &F, NodeArray< DPoint > &F_attr, NodeArray< DPoint > &F_rep, NodeArray< DPoint > &last_node_movement, int iter, int fine_tuning_step)
The forces are calculated here.
void postStrengthOfRepForces(double x)
Sets the strength of the repulsive forces in the postprocessing step to x.
bool newInitialPlacement() const
Returns the current setting of option newInitialPlacement.
FMMMOptions::ForceModel m_forceModel
The used force model.
void create_initial_placement_uniform_grid(const Graph &G, NodeArray< NodeAttributes > &A)
Places nodes uniformly in a grid.
void call_DIVIDE_ET_IMPERA_step(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E)
Calls the divide (decomposition into connected components) and impera (drawing and packing of the com...
void nmTreeConstruction(FMMMOptions::ReducedTreeConstruction rtc)
Sets the option nmTreeConstruction to rtc.
FMMMOptions::TipOver tipOverCCs() const
Returns the current setting of option tipOverCCs.
void update_edgelength(List< edge > &S, EdgeArray< double > &new_edgelength, EdgeArray< EdgeAttributes > &E_reduced)
Sets for each edge e of G_reduced in S its edgelength to new_edgelength[e].
double minDistCC() const
Returns the minimal distance between connected components.
double time_total
The runtime (=CPU-time) of the algorithm in seconds.
void springStrength(double x)
Sets the strength of the springs to x.
void call(ClusterGraphAttributes &GA)
Calls the algorithm for clustered graph GA and returns the layout information in GA....
void allowedPositions(FMMMOptions::AllowedPositions ap)
Sets the option allowedPositions to ap.
void set_radii(const Graph &G, NodeArray< NodeAttributes > &A)
The radii of the surrounding circles of the bounding boxes are computed.
void newInitialPlacement(bool nip)
Sets the option newInitialPlacement to nip.
double m_unitEdgeLength
The unit edge length.
double m_threshold
The threshold for the stop criterion.
double m_postSpringStrength
The strength of springs during postprocessing.
FMMMOptions::PageFormatType pageFormat() const
Returns the current setting of option pageFormat.
double calculate_area(double width, double height, int comp_nr)
Returns the area (aspect ratio area) of a rectangle with width w and height h if comp_nr > 1 ( comp_n...
void call_FORCE_CALCULATION_step(Graph &G, NodeArray< NodeAttributes > &A, EdgeArray< EdgeAttributes > &E, int act_level, int max_level)
Calls the force calculation step for G, A, E.
void calculate_repulsive_forces(Graph &G, NodeArray< NodeAttributes > &A, NodeArray< DPoint > &F_rep)
Calculates repulsive forces for each node.
void init_last_node_movement(Graph &G, NodeArray< DPoint > &F, NodeArray< DPoint > &last_node_movement)
last_node_movement is initialized to F (used after first iteration).
void call(GraphAttributes &GA, const EdgeArray< double > &edgeLength, char *ps_file)
Extend algorithm call: Allows to pass desired lengths of the edges.
int randomTries() const
Returns the current setting of option randomTries.
StopCriterion
Specifies the stop criterion.
InitialPlacementForces
Specifies how the initial placement is done.
QualityVsSpeed
Trade-off between run-time and quality.
InitialPlacementMult
Specifies how the initial placement is generated.
AllowedPositions
Specifies which positions for a node are allowed.
RepulsiveForcesMethod
Specifies how to calculate repulsive forces.
EdgeLengthMeasurement
Specifies how the length of an edge is measured.
SmallestCellFinding
Specifies how to calculate the smallest quadratic cell that surrounds the particles of a node in the ...
ReducedTreeConstruction
Specifies how the reduced bucket quadtree is constructed.
MaxIterChange
Specifies how MaxIterations is changed in subsequent multilevels.
ForceModel
Specifies the force model.
PreSort
Specifies how connected components are sorted before the packing algorithm is applied.
TipOver
Specifies in which case it is allowed to tip over drawings of connected components.
GalaxyChoice
Specifies how sun nodes of galaxies are selected.
PageFormatType
Possible page formats.
Stores additional attributes of a graph (like layout information).
Data type for general directed graphs (adjacency list representation).
Interface of general layout algorithms.
Doubly linked lists (maintaining the length of the list).
Dynamic arrays indexed with nodes.
helping data structure that stores the graphical attributes of an edge that are needed for the force-...
void calculate_approx_repulsive_forces(const Graph &G, NodeArray< NodeAttributes > &A, NodeArray< DPoint > &F_rep)
Grid approximation of rep.forces for each node.
void calculate_exact_repulsive_forces(const Graph &G, NodeArray< NodeAttributes > &A, NodeArray< DPoint > &F_rep)
Calculate exact rep. forces for each node.
void calculate_repulsive_forces(const Graph &G, NodeArray< NodeAttributes > &A, NodeArray< DPoint > &F_rep)
Calculate rep. forces for each node.
void deallocate_memory()
Dynamically allocated memory is freed here.
helping data structure that stores the graphical attributes of a node that are needed for the force-d...
Helping data structure for packing rectangles; The width, height and the position of the down left co...
#define OGDF_EXPORT
Specifies that a function or class is exported by the OGDF DLL.
Declaration of class Rectangle.
#define OGDF_ASSERT(expr)
Assert condition expr. See doc/build.md for more information.
static MultilevelBuilder * getDoubleFactoredZeroAdjustedMerger()
The namespace for all OGDF objects.