mirror of
				https://github.com/SoftFever/OrcaSlicer.git
				synced 2025-10-24 17:21:11 -06:00 
			
		
		
		
	Merge branch 'master' into lm_tm_hollowing
This commit is contained in:
		
						commit
						537260494d
					
				
					 185 changed files with 83280 additions and 4591 deletions
				
			
		|  | @ -169,7 +169,7 @@ void Fill3DHoneycomb::_fill_surface_single( | |||
|         if (params.dont_connect) | ||||
|             append(polylines_out, std::move(polylines_chained)); | ||||
|         else | ||||
|             this->connect_infill(std::move(polylines_chained), expolygon, polylines_out, params); | ||||
|             this->connect_infill(std::move(polylines_chained), expolygon, polylines_out, this->spacing, params); | ||||
|     } | ||||
| } | ||||
| 
 | ||||
|  |  | |||
|  | @ -2,6 +2,7 @@ | |||
| 
 | ||||
| #include "../ClipperUtils.hpp" | ||||
| #include "../EdgeGrid.hpp" | ||||
| #include "../Geometry.hpp" | ||||
| #include "../Surface.hpp" | ||||
| #include "../PrintConfig.hpp" | ||||
| #include "../libslic3r.h" | ||||
|  | @ -609,16 +610,15 @@ static inline SegmentPoint clip_start_segment_and_point(const Points &polyline, | |||
| 	// Initialized to "invalid".
 | ||||
| 	SegmentPoint out; | ||||
| 	if (polyline.size() >= 2) { | ||||
| 		const double d2 = distance * distance; | ||||
| 	    Vec2d pt_prev = polyline.front().cast<double>(); | ||||
| 		for (int i = 1; i < polyline.size(); ++ i) { | ||||
| 			Vec2d pt = polyline[i].cast<double>(); | ||||
| 			Vec2d v = pt - pt_prev; | ||||
| 	        double l2 = v.squaredNorm(); | ||||
| 	        if (l2 > d2) { | ||||
| 	        if (l2 > distance * distance) { | ||||
| 	        	out.idx_segment = i; | ||||
| 	        	out.t 			= distance / sqrt(l2); | ||||
| 	        	out.point 		= pt + out.t * v; | ||||
| 	        	out.point 		= pt_prev + out.t * v; | ||||
| 	            break; | ||||
| 	        } | ||||
| 	        distance -= sqrt(l2); | ||||
|  | @ -635,16 +635,17 @@ static inline SegmentPoint clip_end_segment_and_point(const Points &polyline, do | |||
| 	// Initialized to "invalid".
 | ||||
| 	SegmentPoint out; | ||||
| 	if (polyline.size() >= 2) { | ||||
| 		const double d2 = distance * distance; | ||||
| 	    Vec2d pt_next = polyline.back().cast<double>(); | ||||
| 		for (int i = int(polyline.size()) - 2; i >= 0; -- i) { | ||||
| 			Vec2d pt = polyline[i].cast<double>(); | ||||
| 			Vec2d v = pt - pt_next; | ||||
| 	        double l2 = v.squaredNorm(); | ||||
| 	        if (l2 > d2) { | ||||
| 	        if (l2 > distance * distance) { | ||||
| 	        	out.idx_segment = i; | ||||
| 	        	out.t 			= distance / sqrt(l2); | ||||
| 	        	out.point 		= pt + out.t * v; | ||||
| 	        	out.point 		= pt_next + out.t * v; | ||||
| 				// Store the parameter referenced to the starting point of a segment.
 | ||||
| 				out.t			= 1. - out.t; | ||||
| 	            break; | ||||
| 	        } | ||||
| 	        distance -= sqrt(l2); | ||||
|  | @ -654,21 +655,26 @@ static inline SegmentPoint clip_end_segment_and_point(const Points &polyline, do | |||
| 	return out; | ||||
| } | ||||
| 
 | ||||
| // Optimized version with the precalculated v1 = p1b - p1a and l1_2 = v1.squaredNorm().
 | ||||
| // Assumption: l1_2 < EPSILON.
 | ||||
| static inline double segment_point_distance_squared(const Vec2d &p1a, const Vec2d &p1b, const Vec2d &v1, const double l1_2, const Vec2d &p2) | ||||
| { | ||||
| 	assert(l1_2 > EPSILON); | ||||
| 	Vec2d  v12 = p2 - p1a; | ||||
| 	double t   = v12.dot(v1); | ||||
| 	return (t <= 0.  ) ? v12.squaredNorm() : | ||||
| 	       (t >= l1_2) ? (p2 - p1a).squaredNorm() : | ||||
| 		   ((t / l1_2) * v1 - v12).squaredNorm(); | ||||
| } | ||||
| 
 | ||||
| static inline double segment_point_distance_squared(const Vec2d &p1a, const Vec2d &p1b, const Vec2d &p2) | ||||
| { | ||||
|     const Vec2d   v  = p1b - p1a; | ||||
|     const Vec2d   va = p2  - p1a; | ||||
|     const double  l2 = v.squaredNorm(); | ||||
|     const Vec2d  v  = p1b - p1a; | ||||
|     const double l2 = v.squaredNorm(); | ||||
|     if (l2 < EPSILON) | ||||
|         // p1a == p1b
 | ||||
|         return va.squaredNorm(); | ||||
|     // Project p2 onto the (p1a, p1b) segment.
 | ||||
|     const double t = va.dot(v); | ||||
|     if (t < 0.) | ||||
|     	return va.squaredNorm(); | ||||
|     else if (t > l2) | ||||
|     	return (p2 - p1b).squaredNorm(); | ||||
|     return ((t / l2) * v - va).squaredNorm(); | ||||
|         return (p2  - p1a).squaredNorm(); | ||||
| 	return segment_point_distance_squared(p1a, p1b, v, v.squaredNorm(), p2); | ||||
| } | ||||
| 
 | ||||
| // Distance to the closest point of line.
 | ||||
|  | @ -684,43 +690,11 @@ static inline double min_distance_of_segments(const Vec2d &p1a, const Vec2d &p1b | |||
|     double  l2_2 	= v2.squaredNorm(); | ||||
|     if (l2_2 < EPSILON) | ||||
|         // p2a == p2b: Return distance of p2a from the (p1a, p1b) segment.
 | ||||
|         return segment_point_distance_squared(p1a, p1b, p2a); | ||||
| 
 | ||||
|     // Project p2a, p2b onto the (p1a, p1b) segment.
 | ||||
| 	auto project_p2a_p2b_onto_seg_p1a_p1b = [](const Vec2d& p1a, const Vec2d& p1b, const Vec2d& p2a, const Vec2d& p2b, const Vec2d& v1, const double l1_2) { | ||||
| 		Vec2d   v1a2a = p2a - p1a; | ||||
| 		Vec2d   v1a2b = p2b - p1a; | ||||
| 		double 	t1 = v1a2a.dot(v1); | ||||
| 		double 	t2 = v1a2b.dot(v1); | ||||
| 		if (t1 <= 0.) { | ||||
| 			if (t2 <= 0.) | ||||
| 				// Both p2a and p2b are left of v1.
 | ||||
| 				return (((t1 < t2) ? p2b : p2a) - p1a).squaredNorm(); | ||||
| 			else if (t2 < l1_2) | ||||
| 				// Project p2b onto the (p1a, p1b) segment.
 | ||||
| 				return ((t2 / l1_2) * v1 - v1a2b).squaredNorm(); | ||||
| 		} | ||||
| 		else if (t1 >= l1_2) { | ||||
| 			if (t2 >= l1_2) | ||||
| 				// Both p2a and p2b are right of v1.
 | ||||
| 				return (((t1 < t2) ? p2a : p2b) - p1b).squaredNorm(); | ||||
| 			else if (t2 < l1_2) | ||||
| 				// Project p2b onto the (p1a, p1b) segment.
 | ||||
| 				return ((t2 / l1_2) * v1 - v1a2b).squaredNorm(); | ||||
| 		} | ||||
| 		else { | ||||
| 			// Project p1b onto the (p1a, p1b) segment.
 | ||||
| 			double dist_min = ((t2 / l1_2) * v1 - v1a2a).squaredNorm(); | ||||
| 			if (t2 > 0. && t2 < l1_2) | ||||
| 				dist_min = std::min(dist_min, ((t2 / l1_2) * v1 - v1a2b).squaredNorm()); | ||||
| 			return dist_min; | ||||
| 		} | ||||
| 		return std::numeric_limits<double>::max(); | ||||
| 	}; | ||||
|         return segment_point_distance_squared(p1a, p1b, v1, l1_2, p2a); | ||||
| 
 | ||||
| 	return std::min( | ||||
| 		project_p2a_p2b_onto_seg_p1a_p1b(p1a, p1b, p2a, p2b, v1, l1_2), | ||||
| 		project_p2a_p2b_onto_seg_p1a_p1b(p2a, p2b, p1a, p1b, v2, l2_2)); | ||||
| 		std::min(segment_point_distance_squared(p1a, p1b, v1, l1_2, p2a), segment_point_distance_squared(p1a, p1b, v1, l1_2, p2b)), | ||||
| 		std::min(segment_point_distance_squared(p2a, p2b, v2, l2_2, p1a), segment_point_distance_squared(p2a, p2b, v2, l2_2, p1b))); | ||||
| } | ||||
| 
 | ||||
| // Mark the segments of split boundary as consumed if they are very close to some of the infill line.
 | ||||
|  | @ -756,11 +730,26 @@ void mark_boundary_segments_touching_infill( | |||
| 				const Vec2d seg_pt2 = segment.second.cast<double>(); | ||||
| 				if (min_distance_of_segments(seg_pt1, seg_pt2, *this->pt1, *this->pt2) < this->dist2_max) { | ||||
| 					// Mark this boundary segment as touching the infill line.
 | ||||
| 					ContourPointData&bdp = boundary_data[it_contour_and_segment->first][it_contour_and_segment->second]; | ||||
| 					ContourPointData &bdp = boundary_data[it_contour_and_segment->first][it_contour_and_segment->second]; | ||||
| 					bdp.segment_consumed = true; | ||||
| 					// There is no need for checking seg_pt2 as it will be checked the next time.
 | ||||
| 					if (segment_point_distance_squared(*this->pt1, *this->pt2, seg_pt1) < this->dist2_max) | ||||
| 					bool point_touching = false; | ||||
| 					if (segment_point_distance_squared(*this->pt1, *this->pt2, seg_pt1) < this->dist2_max) { | ||||
| 						point_touching = true; | ||||
| 						bdp.point_consumed = true; | ||||
| 					} | ||||
| #if 0 | ||||
| 					{ | ||||
| 						static size_t iRun = 0; | ||||
| 						ExPolygon expoly(Polygon(*grid.contours().front())); | ||||
| 						for (size_t i = 1; i < grid.contours().size(); ++i) | ||||
| 							expoly.holes.emplace_back(Polygon(*grid.contours()[i])); | ||||
| 						SVG svg(debug_out_path("%s-%d.svg", "FillBase-mark_boundary_segments_touching_infill", iRun ++).c_str(), get_extents(expoly)); | ||||
| 						svg.draw(expoly, "green"); | ||||
| 						svg.draw(Line(segment.first, segment.second), "red"); | ||||
| 						svg.draw(Line(this->pt1->cast<coord_t>(), this->pt2->cast<coord_t>()), "magenta"); | ||||
| 					} | ||||
| #endif | ||||
| 				} | ||||
| 			} | ||||
| 			// Continue traversing the grid along the edge.
 | ||||
|  | @ -777,6 +766,9 @@ void mark_boundary_segments_touching_infill( | |||
| 		const Vec2d 								*pt2; | ||||
| 	} visitor(grid, boundary, boundary_data, distance_colliding * distance_colliding); | ||||
| 
 | ||||
| 	BoundingBoxf bboxf(boundary_bbox.min.cast<double>(), boundary_bbox.max.cast<double>()); | ||||
| 	bboxf.offset(- SCALED_EPSILON); | ||||
| 
 | ||||
| 	for (const Polyline &polyline : infill) { | ||||
| 		// Clip the infill polyline by the Eucledian distance along the polyline.
 | ||||
| 		SegmentPoint start_point = clip_start_segment_and_point(polyline.points, clip_distance); | ||||
|  | @ -806,25 +798,39 @@ void mark_boundary_segments_touching_infill( | |||
| 				visitor.init(pt1d, pt2d); | ||||
| 				grid.visit_cells_intersecting_thick_line(pt1, pt2, distance_colliding, visitor); | ||||
| #else | ||||
| 				Vec2d pt1 = (point_idx == start_point.idx_segment) ? start_point.point : polyline.points[point_idx].cast<double>(); | ||||
| 				Vec2d pt2 = (point_idx == end_point  .idx_segment) ? end_point  .point : polyline.points[point_idx].cast<double>(); | ||||
| 				Vec2d pt1 = (point_idx == start_point.idx_segment) ? start_point.point : polyline.points[point_idx    ].cast<double>(); | ||||
| 				Vec2d pt2 = (point_idx == end_point  .idx_segment) ? end_point  .point : polyline.points[point_idx + 1].cast<double>(); | ||||
| #if 0 | ||||
| 					{ | ||||
| 						static size_t iRun = 0; | ||||
| 						ExPolygon expoly(Polygon(*grid.contours().front())); | ||||
| 						for (size_t i = 1; i < grid.contours().size(); ++i) | ||||
| 							expoly.holes.emplace_back(Polygon(*grid.contours()[i])); | ||||
| 						SVG svg(debug_out_path("%s-%d.svg", "FillBase-mark_boundary_segments_touching_infill0", iRun ++).c_str(), get_extents(expoly)); | ||||
| 						svg.draw(expoly, "green"); | ||||
| 						svg.draw(polyline, "blue"); | ||||
| 						svg.draw(Line(pt1.cast<coord_t>(), pt2.cast<coord_t>()), "magenta", scale_(0.1)); | ||||
| 					} | ||||
| #endif | ||||
| 				visitor.init(pt1, pt2); | ||||
| 				// Simulate tracing of a thick line. This only works reliably if distance_colliding <= grid cell size.
 | ||||
| 				Vec2d v = (pt2 - pt1).normalized() * distance_colliding; | ||||
| 				Vec2d vperp(-v.y(), v.x()); | ||||
| 				Vec2d a = pt1 - v - vperp; | ||||
| 				Vec2d b = pt1 + v - vperp; | ||||
| 				grid.visit_cells_intersecting_line(a.cast<coord_t>(), b.cast<coord_t>(), visitor); | ||||
| 				if (Geometry::liang_barsky_line_clipping(a, b, bboxf)) | ||||
| 					grid.visit_cells_intersecting_line(a.cast<coord_t>(), b.cast<coord_t>(), visitor); | ||||
| 				a = pt1 - v + vperp; | ||||
| 				b = pt1 + v + vperp; | ||||
| 				grid.visit_cells_intersecting_line(a.cast<coord_t>(), b.cast<coord_t>(), visitor); | ||||
| 				if (Geometry::liang_barsky_line_clipping(a, b, bboxf)) | ||||
| 					grid.visit_cells_intersecting_line(a.cast<coord_t>(), b.cast<coord_t>(), visitor); | ||||
| #endif | ||||
| 			} | ||||
| 		} | ||||
| 	} | ||||
| } | ||||
| 
 | ||||
| void Fill::connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary_src, Polylines &polylines_out, const FillParams ¶ms) | ||||
| void Fill::connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary_src, Polylines &polylines_out, const double spacing, const FillParams ¶ms) | ||||
| { | ||||
| 	assert(! infill_ordered.empty()); | ||||
| 	assert(! boundary_src.contour.points.empty()); | ||||
|  | @ -900,16 +906,16 @@ void Fill::connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary_ | |||
| 
 | ||||
| 	// Mark the points and segments of split boundary as consumed if they are very close to some of the infill line.
 | ||||
| 	{ | ||||
| 		//const double clip_distance		= scale_(this->spacing);
 | ||||
| 		const double clip_distance		= 3. * scale_(this->spacing); | ||||
| 		const double distance_colliding = scale_(this->spacing); | ||||
| 		// @supermerill used 2. * scale_(spacing)
 | ||||
| 		const double clip_distance		= 3. * scale_(spacing); | ||||
| 		const double distance_colliding = 1.1 * scale_(spacing); | ||||
| 		mark_boundary_segments_touching_infill(boundary, boundary_data, bbox, infill_ordered, clip_distance, distance_colliding); | ||||
| 	} | ||||
| 
 | ||||
| 	// Connection from end of one infill line to the start of another infill line.
 | ||||
| 	//const float length_max = scale_(this->spacing);
 | ||||
| //	const float length_max = scale_((2. / params.density) * this->spacing);
 | ||||
| 	const float length_max = scale_((1000. / params.density) * this->spacing); | ||||
| 	//const float length_max = scale_(spacing);
 | ||||
| //	const float length_max = scale_((2. / params.density) * spacing);
 | ||||
| 	const float length_max = scale_((1000. / params.density) * spacing); | ||||
| 	std::vector<size_t> merged_with(infill_ordered.size()); | ||||
| 	for (size_t i = 0; i < merged_with.size(); ++ i) | ||||
| 		merged_with[i] = i; | ||||
|  | @ -951,12 +957,26 @@ void Fill::connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary_ | |||
| 
 | ||||
| 	size_t idx_chain_last = 0; | ||||
| 	for (ConnectionCost &connection_cost : connections_sorted) { | ||||
| 		const std::pair<size_t, size_t>	*cp1 = &map_infill_end_point_to_boundary[connection_cost.idx_first * 2 + 1]; | ||||
| 		const std::pair<size_t, size_t>	*cp2 = &map_infill_end_point_to_boundary[(connection_cost.idx_first + 1) * 2]; | ||||
| 		const std::pair<size_t, size_t>	*cp1     = &map_infill_end_point_to_boundary[connection_cost.idx_first * 2 + 1]; | ||||
| 		const std::pair<size_t, size_t>	*cp1prev = cp1 - 1; | ||||
| 		const std::pair<size_t, size_t>	*cp2     = &map_infill_end_point_to_boundary[(connection_cost.idx_first + 1) * 2]; | ||||
| 		const std::pair<size_t, size_t>	*cp2next = cp2 + 1; | ||||
| 		assert(cp1->first == cp2->first); | ||||
| 		std::vector<ContourPointData>	&contour_data = boundary_data[cp1->first]; | ||||
| 		if (connection_cost.reversed) | ||||
| 			std::swap(cp1, cp2); | ||||
| 		// Mark the the other end points of the segments to be taken as consumed temporarily, so they will not be crossed
 | ||||
| 		// by the new connection line.
 | ||||
| 		bool prev_marked = false; | ||||
| 		bool next_marked = false; | ||||
| 		if (cp1prev->first == cp1->first && ! contour_data[cp1prev->second].point_consumed) { | ||||
| 			contour_data[cp1prev->second].point_consumed = true; | ||||
| 			prev_marked = true; | ||||
| 		} | ||||
| 		if (cp2next->first == cp1->first && ! contour_data[cp2next->second].point_consumed) { | ||||
| 			contour_data[cp2next->second].point_consumed = true; | ||||
| 			next_marked = true; | ||||
| 		} | ||||
| 		if (could_take(contour_data, cp1->second, cp2->second)) { | ||||
| 			// Indices of the polygons to be connected.
 | ||||
| 			size_t idx_first  = connection_cost.idx_first; | ||||
|  | @ -975,6 +995,10 @@ void Fill::connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary_ | |||
| 			// Mark the second polygon as merged with the first one.
 | ||||
| 			merged_with[idx_second] = merged_with[idx_first]; | ||||
| 		} | ||||
| 		if (prev_marked) | ||||
| 			contour_data[cp1prev->second].point_consumed = false; | ||||
| 		if (next_marked) | ||||
| 			contour_data[cp2next->second].point_consumed = false; | ||||
| 	} | ||||
| 	polylines_out.reserve(polylines_out.size() + std::count_if(infill_ordered.begin(), infill_ordered.end(), [](const Polyline &pl) { return ! pl.empty(); })); | ||||
| 	for (Polyline &pl : infill_ordered) | ||||
|  |  | |||
|  | @ -111,9 +111,9 @@ protected: | |||
| 
 | ||||
|     virtual std::pair<float, Point> _infill_direction(const Surface *surface) const; | ||||
| 
 | ||||
|     void connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary, Polylines &polylines_out, const FillParams ¶ms); | ||||
| 
 | ||||
| public: | ||||
|     static void connect_infill(Polylines &&infill_ordered, const ExPolygon &boundary, Polylines &polylines_out, double spacing, const FillParams ¶ms); | ||||
| 
 | ||||
|     static coord_t  _adjust_solid_spacing(const coord_t width, const coord_t distance); | ||||
| 
 | ||||
|     // Align a coordinate to a grid. The coordinate may be negative,
 | ||||
|  |  | |||
|  | @ -185,6 +185,7 @@ void FillGyroid::_fill_surface_single( | |||
|     if (! polylines.empty()) | ||||
| 		// remove too small bits (larger than longer)
 | ||||
| 		polylines.erase( | ||||
| 			//FIXME what is the small size? Removing tiny extrusions disconnects walls!
 | ||||
| 			std::remove_if(polylines.begin(), polylines.end(), [this](const Polyline &pl) { return pl.length() < scale_(this->spacing * 3); }), | ||||
| 			polylines.end()); | ||||
| 
 | ||||
|  | @ -195,7 +196,7 @@ void FillGyroid::_fill_surface_single( | |||
| 		if (params.dont_connect) | ||||
|         	append(polylines_out, std::move(polylines)); | ||||
|         else | ||||
|             this->connect_infill(std::move(polylines), expolygon, polylines_out, params); | ||||
|             this->connect_infill(std::move(polylines), expolygon, polylines_out, this->spacing, params); | ||||
| 	    // new paths must be rotated back
 | ||||
| 	    if (abs(infill_angle) >= EPSILON) { | ||||
| 	        for (auto it = polylines_out.begin() + polylines_out_first_idx; it != polylines_out.end(); ++ it) | ||||
|  |  | |||
|  | @ -52,6 +52,7 @@ const std::string LAYER_HEIGHTS_PROFILE_FILE = "Metadata/Slic3r_PE_layer_heights | |||
| const std::string LAYER_CONFIG_RANGES_FILE = "Metadata/Prusa_Slicer_layer_config_ranges.xml"; | ||||
| const std::string SLA_SUPPORT_POINTS_FILE = "Metadata/Slic3r_PE_sla_support_points.txt"; | ||||
| const std::string SLA_DRAIN_HOLES_FILE = "Metadata/Slic3r_PE_sla_drain_holes.txt"; | ||||
| const std::string CUSTOM_GCODE_PER_HEIGHT_FILE = "Metadata/Prusa_Slicer_custom_gcode_per_height.xml"; | ||||
| 
 | ||||
| const char* MODEL_TAG = "model"; | ||||
| const char* RESOURCES_TAG = "resources"; | ||||
|  | @ -421,6 +422,8 @@ namespace Slic3r { | |||
|         void _extract_sla_support_points_from_archive(mz_zip_archive& archive, const mz_zip_archive_file_stat& stat); | ||||
|         void _extract_sla_drain_holes_from_archive(mz_zip_archive& archive, const mz_zip_archive_file_stat& stat); | ||||
| 
 | ||||
|         void _extract_custom_gcode_per_height_from_archive(mz_zip_archive& archive, const mz_zip_archive_file_stat& stat); | ||||
| 
 | ||||
|         void _extract_print_config_from_archive(mz_zip_archive& archive, const mz_zip_archive_file_stat& stat, DynamicPrintConfig& config, const std::string& archive_filename); | ||||
|         bool _extract_model_config_from_archive(mz_zip_archive& archive, const mz_zip_archive_file_stat& stat, Model& model); | ||||
| 
 | ||||
|  | @ -635,6 +638,11 @@ namespace Slic3r { | |||
|                     // extract slic3r print config file
 | ||||
|                     _extract_print_config_from_archive(archive, stat, config, filename); | ||||
|                 } | ||||
|                 if (boost::algorithm::iequals(name, CUSTOM_GCODE_PER_HEIGHT_FILE)) | ||||
|                 { | ||||
|                     // extract slic3r layer config ranges file
 | ||||
|                     _extract_custom_gcode_per_height_from_archive(archive, stat); | ||||
|                 } | ||||
|                 else if (boost::algorithm::iequals(name, MODEL_CONFIG_FILE)) | ||||
|                 { | ||||
|                     // extract slic3r model config file
 | ||||
|  | @ -1155,6 +1163,43 @@ namespace Slic3r { | |||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|     void _3MF_Importer::_extract_custom_gcode_per_height_from_archive(::mz_zip_archive &archive, const mz_zip_archive_file_stat &stat) | ||||
|     { | ||||
|         if (stat.m_uncomp_size > 0) | ||||
|         { | ||||
|             std::string buffer((size_t)stat.m_uncomp_size, 0); | ||||
|             mz_bool res = mz_zip_reader_extract_file_to_mem(&archive, stat.m_filename, (void*)buffer.data(), (size_t)stat.m_uncomp_size, 0); | ||||
|             if (res == 0) { | ||||
|                 add_error("Error while reading custom Gcodes per height data to buffer"); | ||||
|                 return; | ||||
|             } | ||||
| 
 | ||||
|             std::istringstream iss(buffer); // wrap returned xml to istringstream
 | ||||
|             pt::ptree main_tree; | ||||
|             pt::read_xml(iss, main_tree); | ||||
| 
 | ||||
|             if (main_tree.front().first != "custom_gcodes_per_height") | ||||
|                 return; | ||||
|             pt::ptree code_tree = main_tree.front().second; | ||||
| 
 | ||||
|             if (!m_model->custom_gcode_per_height.empty()) | ||||
|                 m_model->custom_gcode_per_height.clear(); | ||||
| 
 | ||||
|             for (const auto& code : code_tree) | ||||
|             { | ||||
|                 if (code.first != "code") | ||||
|                     continue; | ||||
|                 pt::ptree tree = code.second; | ||||
|                 double height       = tree.get<double>("<xmlattr>.height"); | ||||
|                 std::string gcode   = tree.get<std::string>("<xmlattr>.gcode"); | ||||
|                 int extruder        = tree.get<int>("<xmlattr>.extruder"); | ||||
|                 std::string color   = tree.get<std::string>("<xmlattr>.color"); | ||||
| 
 | ||||
|                 m_model->custom_gcode_per_height.push_back(Model::CustomGCode(height, gcode, extruder, color)) ; | ||||
|             } | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
|     void _3MF_Importer::_handle_start_model_xml_element(const char* name, const char** attributes) | ||||
|     { | ||||
|         if (m_xml_parser == nullptr) | ||||
|  | @ -1568,8 +1613,10 @@ namespace Slic3r { | |||
| 
 | ||||
|             if (m_check_version && (m_version > VERSION_3MF)) | ||||
|             { | ||||
|                 std::string msg = _(L("The selected 3mf file has been saved with a newer version of " + std::string(SLIC3R_APP_NAME) + " and is not compatible.")); | ||||
|                 throw version_error(msg.c_str()); | ||||
|                 // std::string msg = _(L("The selected 3mf file has been saved with a newer version of " + std::string(SLIC3R_APP_NAME) + " and is not compatible."));
 | ||||
|                 // throw version_error(msg.c_str());
 | ||||
|                 const std::string msg = (boost::format(_(L("The selected 3mf file has been saved with a newer version of %1% and is not compatible."))) % std::string(SLIC3R_APP_NAME)).str(); | ||||
|                 throw version_error(msg); | ||||
|             } | ||||
|         } | ||||
| 
 | ||||
|  | @ -1938,6 +1985,7 @@ namespace Slic3r { | |||
|         bool _add_sla_drain_holes_file_to_archive(mz_zip_archive& archive, Model& model); | ||||
|         bool _add_print_config_file_to_archive(mz_zip_archive& archive, const DynamicPrintConfig &config); | ||||
|         bool _add_model_config_file_to_archive(mz_zip_archive& archive, const Model& model, const IdToObjectDataMap &objects_data); | ||||
|         bool _add_custom_gcode_per_height_file_to_archive(mz_zip_archive& archive, Model& model); | ||||
|     }; | ||||
| 
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|  | @ -2048,6 +2096,15 @@ namespace Slic3r { | |||
|         } | ||||
|          | ||||
| 
 | ||||
|         // Adds custom gcode per height file ("Metadata/Prusa_Slicer_custom_gcode_per_height.xml").
 | ||||
|         // All custom gcode per height of whole Model are stored here
 | ||||
|         if (!_add_custom_gcode_per_height_file_to_archive(archive, model)) | ||||
|         { | ||||
|             close_zip_writer(&archive); | ||||
|             boost::filesystem::remove(filename); | ||||
|             return false; | ||||
|         } | ||||
| 
 | ||||
|         // Adds slic3r print config file ("Metadata/Slic3r_PE.config").
 | ||||
|         // This file contains the content of FullPrintConfing / SLAFullPrintConfig.
 | ||||
|         if (config != nullptr) | ||||
|  | @ -2432,7 +2489,7 @@ namespace Slic3r { | |||
|         if (!tree.empty()) | ||||
|         { | ||||
|             std::ostringstream oss; | ||||
|             boost::property_tree::write_xml(oss, tree); | ||||
|             pt::write_xml(oss, tree); | ||||
|             out = oss.str(); | ||||
| 
 | ||||
|             // Post processing("beautification") of the output string for a better preview
 | ||||
|  | @ -2662,7 +2719,49 @@ namespace Slic3r { | |||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|     bool load_3mf(const char* path, DynamicPrintConfig* config, Model* model, bool check_version) | ||||
| bool _3MF_Exporter::_add_custom_gcode_per_height_file_to_archive( mz_zip_archive& archive, Model& model) | ||||
| { | ||||
|     std::string out = ""; | ||||
| 
 | ||||
|     if (!model.custom_gcode_per_height.empty()) | ||||
|     { | ||||
|         pt::ptree tree; | ||||
|         pt::ptree& main_tree = tree.add("custom_gcodes_per_height", ""); | ||||
| 
 | ||||
|         for (const Model::CustomGCode& code : model.custom_gcode_per_height) | ||||
|         { | ||||
|             pt::ptree& code_tree = main_tree.add("code", ""); | ||||
|             // store minX and maxZ
 | ||||
|             code_tree.put("<xmlattr>.height"    , code.height   ); | ||||
|             code_tree.put("<xmlattr>.gcode"     , code.gcode    ); | ||||
|             code_tree.put("<xmlattr>.extruder"  , code.extruder ); | ||||
|             code_tree.put("<xmlattr>.color"     , code.color    ); | ||||
|         }        | ||||
| 
 | ||||
|         if (!tree.empty()) | ||||
|         { | ||||
|             std::ostringstream oss; | ||||
|             boost::property_tree::write_xml(oss, tree); | ||||
|             out = oss.str(); | ||||
| 
 | ||||
|             // Post processing("beautification") of the output string
 | ||||
|             boost::replace_all(out, "><", ">\n<"); | ||||
|         } | ||||
|     }  | ||||
| 
 | ||||
|     if (!out.empty()) | ||||
|     { | ||||
|         if (!mz_zip_writer_add_mem(&archive, CUSTOM_GCODE_PER_HEIGHT_FILE.c_str(), (const void*)out.data(), out.length(), MZ_DEFAULT_COMPRESSION)) | ||||
|         { | ||||
|             add_error("Unable to add custom Gcodes per height file to archive"); | ||||
|             return false; | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
|     return true; | ||||
| } | ||||
| 
 | ||||
| bool load_3mf(const char* path, DynamicPrintConfig* config, Model* model, bool check_version) | ||||
|     { | ||||
|         if ((path == nullptr) || (config == nullptr) || (model == nullptr)) | ||||
|             return false; | ||||
|  |  | |||
|  | @ -16,6 +16,10 @@ | |||
| 
 | ||||
| #include "AMF.hpp" | ||||
| 
 | ||||
| #include <boost/property_tree/ptree.hpp> | ||||
| #include <boost/property_tree/xml_parser.hpp> | ||||
| namespace pt = boost::property_tree; | ||||
| 
 | ||||
| #include <boost/filesystem/operations.hpp> | ||||
| #include <boost/algorithm/string.hpp> | ||||
| #include <boost/nowide/fstream.hpp> | ||||
|  | @ -147,6 +151,8 @@ struct AMFParserContext | |||
|         NODE_TYPE_MIRRORY,              // amf/constellation/instance/mirrory
 | ||||
|         NODE_TYPE_MIRRORZ,              // amf/constellation/instance/mirrorz
 | ||||
|         NODE_TYPE_PRINTABLE,            // amf/constellation/instance/mirrorz
 | ||||
|         NODE_TYPE_CUSTOM_GCODE,         // amf/custom_code_per_height
 | ||||
|         NODE_TYPE_GCODE_PER_HEIGHT,     // amf/custom_code_per_height/code
 | ||||
|         NODE_TYPE_METADATA,             // anywhere under amf/*/metadata
 | ||||
|     }; | ||||
| 
 | ||||
|  | @ -227,7 +233,7 @@ struct AMFParserContext | |||
|     // Current instance allocated for an amf/constellation/instance subtree.
 | ||||
|     Instance                *m_instance; | ||||
|     // Generic string buffer for vertices, face indices, metadata etc.
 | ||||
|     std::string              m_value[3]; | ||||
|     std::string              m_value[4]; | ||||
|     // Pointer to config to update if config data are stored inside the amf file
 | ||||
|     DynamicPrintConfig      *m_config; | ||||
| 
 | ||||
|  | @ -268,6 +274,8 @@ void AMFParserContext::startElement(const char *name, const char **atts) | |||
|             } | ||||
|         } else if (strcmp(name, "constellation") == 0) { | ||||
|             node_type_new = NODE_TYPE_CONSTELLATION; | ||||
|         } else if (strcmp(name, "custom_gcodes_per_height") == 0) { | ||||
|             node_type_new = NODE_TYPE_CUSTOM_GCODE; | ||||
|         } | ||||
|         break; | ||||
|     case 2: | ||||
|  | @ -294,6 +302,13 @@ void AMFParserContext::startElement(const char *name, const char **atts) | |||
|             } | ||||
|             else | ||||
|                 this->stop(); | ||||
|         }  | ||||
|         else if (strcmp(name, "code") == 0 && m_path[1] == NODE_TYPE_CUSTOM_GCODE) { | ||||
|             node_type_new = NODE_TYPE_GCODE_PER_HEIGHT; | ||||
|             m_value[0] = get_attribute(atts, "height"); | ||||
|             m_value[1] = get_attribute(atts, "gcode"); | ||||
|             m_value[2] = get_attribute(atts, "extruder"); | ||||
|             m_value[3] = get_attribute(atts, "color"); | ||||
|         } | ||||
|         break; | ||||
|     case 3: | ||||
|  | @ -616,6 +631,19 @@ void AMFParserContext::endElement(const char * /* name */) | |||
|         m_instance = nullptr; | ||||
|         break; | ||||
| 
 | ||||
|     case NODE_TYPE_GCODE_PER_HEIGHT: { | ||||
|         double height = double(atof(m_value[0].c_str())); | ||||
|         const std::string& gcode = m_value[1]; | ||||
|         int extruder = atoi(m_value[2].c_str()); | ||||
|         const std::string& color = m_value[3]; | ||||
| 
 | ||||
|         m_model.custom_gcode_per_height.push_back(Model::CustomGCode(height, gcode, extruder, color)); | ||||
| 
 | ||||
|         for (std::string& val: m_value) | ||||
|             val.clear(); | ||||
|         break; | ||||
|         } | ||||
| 
 | ||||
|     case NODE_TYPE_METADATA: | ||||
|         if ((m_config != nullptr) && strncmp(m_value[0].c_str(), SLIC3R_CONFIG_TYPE, strlen(SLIC3R_CONFIG_TYPE)) == 0) | ||||
|             m_config->load_from_gcode_string(m_value[1].c_str()); | ||||
|  | @ -884,8 +912,10 @@ bool extract_model_from_archive(mz_zip_archive& archive, const mz_zip_archive_fi | |||
| 
 | ||||
|     if (check_version && (ctx.m_version > VERSION_AMF)) | ||||
|     { | ||||
|         std::string msg = _(L("The selected amf file has been saved with a newer version of " + std::string(SLIC3R_APP_NAME) + " and is not compatible.")); | ||||
|         throw std::runtime_error(msg.c_str()); | ||||
|         // std::string msg = _(L("The selected amf file has been saved with a newer version of " + std::string(SLIC3R_APP_NAME) + " and is not compatible."));
 | ||||
|         // throw std::runtime_error(msg.c_str());
 | ||||
|         const std::string msg = (boost::format(_(L("The selected amf file has been saved with a newer version of %1% and is not compatible."))) % std::string(SLIC3R_APP_NAME)).str(); | ||||
|         throw std::runtime_error(msg); | ||||
|     } | ||||
| 
 | ||||
|     return true; | ||||
|  | @ -1190,6 +1220,42 @@ bool store_amf(const char *path, Model *model, const DynamicPrintConfig *config) | |||
|         stream << instances; | ||||
|         stream << "  </constellation>\n"; | ||||
|     } | ||||
| 
 | ||||
|     if (!model->custom_gcode_per_height.empty()) | ||||
|     { | ||||
|         std::string out = ""; | ||||
|         pt::ptree tree; | ||||
| 
 | ||||
|         pt::ptree& main_tree = tree.add("custom_gcodes_per_height", ""); | ||||
| 
 | ||||
|         for (const Model::CustomGCode& code : model->custom_gcode_per_height) | ||||
|         { | ||||
|             pt::ptree& code_tree = main_tree.add("code", ""); | ||||
|             // store minX and maxZ
 | ||||
|             code_tree.put("<xmlattr>.height", code.height); | ||||
|             code_tree.put("<xmlattr>.gcode", code.gcode); | ||||
|             code_tree.put("<xmlattr>.extruder", code.extruder); | ||||
|             code_tree.put("<xmlattr>.color", code.color); | ||||
|         } | ||||
| 
 | ||||
|         if (!tree.empty()) | ||||
|         { | ||||
|             std::ostringstream oss; | ||||
|             pt::write_xml(oss, tree); | ||||
|             out = oss.str(); | ||||
| 
 | ||||
|             int del_header_pos = out.find("<custom_gcodes_per_height"); | ||||
|             if (del_header_pos != std::string::npos) | ||||
|                 out.erase(out.begin(), out.begin() + del_header_pos); | ||||
| 
 | ||||
|             // Post processing("beautification") of the output string
 | ||||
|             boost::replace_all(out, "><code", ">\n  <code"); | ||||
|             boost::replace_all(out, "><", ">\n<"); | ||||
| 
 | ||||
|             stream << out << "\n"; | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
|     stream << "</amf>\n"; | ||||
| 
 | ||||
|     std::string internal_amf_filename = boost::ireplace_last_copy(boost::filesystem::path(export_path).filename().string(), ".zip.amf", ".amf"); | ||||
|  |  | |||
|  | @ -6,9 +6,6 @@ | |||
| #include "Geometry.hpp" | ||||
| #include "GCode/PrintExtents.hpp" | ||||
| #include "GCode/WipeTower.hpp" | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| #include "GCode/ThumbnailData.hpp" | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| #include "ShortestPath.hpp" | ||||
| #include "Utils.hpp" | ||||
| 
 | ||||
|  | @ -35,9 +32,7 @@ | |||
| 
 | ||||
| #include <Shiny/Shiny.h> | ||||
| 
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR_PNG_TO_GCODE | ||||
| #include "miniz_extension.hpp" | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR_PNG_TO_GCODE
 | ||||
| 
 | ||||
| #if 0 | ||||
| // Enable debugging and asserts, even in the release build.
 | ||||
|  | @ -432,39 +427,44 @@ std::string WipeTowerIntegration::post_process_wipe_tower_moves(const WipeTower: | |||
|     Vec2f pos = tcr.start_pos; | ||||
|     Vec2f transformed_pos = pos; | ||||
|     Vec2f old_pos(-1000.1f, -1000.1f); | ||||
|     std::string never_skip_tag = WipeTower::never_skip_tag(); | ||||
| 
 | ||||
|     while (gcode_str) { | ||||
|         std::getline(gcode_str, line);  // we read the gcode line by line
 | ||||
| 
 | ||||
|         // All G1 commands should be translated and rotated
 | ||||
|         // All G1 commands should be translated and rotated. X and Y coords are
 | ||||
|         // only pushed to the output when they differ from last time.
 | ||||
|         // WT generator can override this by appending the never_skip_tag
 | ||||
|         if (line.find("G1 ") == 0) { | ||||
|             bool never_skip = false; | ||||
|             auto it = line.find(never_skip_tag); | ||||
|             if (it != std::string::npos) { | ||||
|                 // remove the tag and remember we saw it
 | ||||
|                 never_skip = true; | ||||
|                 line.erase(it, it+never_skip_tag.size()); | ||||
|             } | ||||
|             std::ostringstream line_out; | ||||
|             std::istringstream line_str(line); | ||||
|             line_str >> std::noskipws;  // don't skip whitespace
 | ||||
|             char ch = 0; | ||||
|             while (line_str >> ch) { | ||||
|                 if (ch == 'X') | ||||
|                     line_str >> pos.x(); | ||||
|                 if (ch == 'X' || ch =='Y') | ||||
|                     line_str >> (ch == 'X' ? pos.x() : pos.y()); | ||||
|                 else | ||||
|                     if (ch == 'Y') | ||||
|                         line_str >> pos.y(); | ||||
|                     else | ||||
|                         line_out << ch; | ||||
|                     line_out << ch; | ||||
|             } | ||||
| 
 | ||||
|             transformed_pos = pos; | ||||
|             transformed_pos = Eigen::Rotation2Df(angle) * transformed_pos; | ||||
|             transformed_pos += translation; | ||||
|             transformed_pos = Eigen::Rotation2Df(angle) * pos + translation; | ||||
| 
 | ||||
|             if (transformed_pos != old_pos) { | ||||
|             if (transformed_pos != old_pos || never_skip) { | ||||
|                 line = line_out.str(); | ||||
|                 std::ostringstream oss; | ||||
|                 oss << std::fixed << std::setprecision(3) << "G1 "; | ||||
|                 if (transformed_pos.x() != old_pos.x()) | ||||
|                 if (transformed_pos.x() != old_pos.x() || never_skip) | ||||
|                     oss << " X" << transformed_pos.x() - extruder_offset.x(); | ||||
|                 if (transformed_pos.y() != old_pos.y()) | ||||
|                 if (transformed_pos.y() != old_pos.y() || never_skip) | ||||
|                     oss << " Y" << transformed_pos.y() - extruder_offset.y(); | ||||
| 
 | ||||
|                 oss << " "; | ||||
|                 line.replace(line.find("G1 "), 3, oss.str()); | ||||
|                 old_pos = transformed_pos; | ||||
|             } | ||||
|  | @ -496,37 +496,37 @@ std::string WipeTowerIntegration::prime(GCode &gcodegen) | |||
|     assert(m_layer_idx == 0); | ||||
|     std::string gcode; | ||||
| 
 | ||||
|     if (&m_priming != nullptr) { | ||||
|         // Disable linear advance for the wipe tower operations.
 | ||||
|             //gcode += (gcodegen.config().gcode_flavor == gcfRepRap ? std::string("M572 D0 S0\n") : std::string("M900 K0\n"));
 | ||||
| 
 | ||||
|         for (const WipeTower::ToolChangeResult& tcr : m_priming) { | ||||
|             if (!tcr.extrusions.empty()) | ||||
|                 gcode += append_tcr(gcodegen, tcr, tcr.new_tool); | ||||
|     // Disable linear advance for the wipe tower operations.
 | ||||
|         //gcode += (gcodegen.config().gcode_flavor == gcfRepRap ? std::string("M572 D0 S0\n") : std::string("M900 K0\n"));
 | ||||
| 
 | ||||
|     for (const WipeTower::ToolChangeResult& tcr : m_priming) { | ||||
|         if (!tcr.extrusions.empty()) | ||||
|             gcode += append_tcr(gcodegen, tcr, tcr.new_tool); | ||||
| 
 | ||||
| 
 | ||||
|             // Let the tool change be executed by the wipe tower class.
 | ||||
|             // Inform the G-code writer about the changes done behind its back.
 | ||||
|             //gcode += tcr.gcode;
 | ||||
|             // Let the m_writer know the current extruder_id, but ignore the generated G-code.
 | ||||
|       //      unsigned int current_extruder_id = tcr.extrusions.back().tool;
 | ||||
|       //      gcodegen.writer().toolchange(current_extruder_id);
 | ||||
|       //      gcodegen.placeholder_parser().set("current_extruder", current_extruder_id);
 | ||||
|         // Let the tool change be executed by the wipe tower class.
 | ||||
|         // Inform the G-code writer about the changes done behind its back.
 | ||||
|         //gcode += tcr.gcode;
 | ||||
|         // Let the m_writer know the current extruder_id, but ignore the generated G-code.
 | ||||
|   //      unsigned int current_extruder_id = tcr.extrusions.back().tool;
 | ||||
|   //      gcodegen.writer().toolchange(current_extruder_id);
 | ||||
|   //      gcodegen.placeholder_parser().set("current_extruder", current_extruder_id);
 | ||||
| 
 | ||||
|         } | ||||
| 
 | ||||
|         // A phony move to the end position at the wipe tower.
 | ||||
|        /* gcodegen.writer().travel_to_xy(Vec2d(m_priming.back().end_pos.x, m_priming.back().end_pos.y));
 | ||||
|         gcodegen.set_last_pos(wipe_tower_point_to_object_point(gcodegen, m_priming.back().end_pos)); | ||||
|         // Prepare a future wipe.
 | ||||
|         gcodegen.m_wipe.path.points.clear(); | ||||
|         // Start the wipe at the current position.
 | ||||
|         gcodegen.m_wipe.path.points.emplace_back(wipe_tower_point_to_object_point(gcodegen, m_priming.back().end_pos)); | ||||
|         // Wipe end point: Wipe direction away from the closer tower edge to the further tower edge.
 | ||||
|         gcodegen.m_wipe.path.points.emplace_back(wipe_tower_point_to_object_point(gcodegen, | ||||
|             WipeTower::xy((std::abs(m_left - m_priming.back().end_pos.x) < std::abs(m_right - m_priming.back().end_pos.x)) ? m_right : m_left, | ||||
|             m_priming.back().end_pos.y)));*/ | ||||
|     } | ||||
| 
 | ||||
|     // A phony move to the end position at the wipe tower.
 | ||||
|    /* gcodegen.writer().travel_to_xy(Vec2d(m_priming.back().end_pos.x, m_priming.back().end_pos.y));
 | ||||
|     gcodegen.set_last_pos(wipe_tower_point_to_object_point(gcodegen, m_priming.back().end_pos)); | ||||
|     // Prepare a future wipe.
 | ||||
|     gcodegen.m_wipe.path.points.clear(); | ||||
|     // Start the wipe at the current position.
 | ||||
|     gcodegen.m_wipe.path.points.emplace_back(wipe_tower_point_to_object_point(gcodegen, m_priming.back().end_pos)); | ||||
|     // Wipe end point: Wipe direction away from the closer tower edge to the further tower edge.
 | ||||
|     gcodegen.m_wipe.path.points.emplace_back(wipe_tower_point_to_object_point(gcodegen, | ||||
|         WipeTower::xy((std::abs(m_left - m_priming.back().end_pos.x) < std::abs(m_right - m_priming.back().end_pos.x)) ? m_right : m_left, | ||||
|         m_priming.back().end_pos.y)));*/ | ||||
| 
 | ||||
|     return gcode; | ||||
| } | ||||
| 
 | ||||
|  | @ -631,7 +631,7 @@ std::vector<GCode::LayerToPrint> GCode::collect_layers_to_print(const PrintObjec | |||
| 
 | ||||
|             if (layer_to_print.print_z() > maximal_print_z + 2. * EPSILON) | ||||
|                 throw std::runtime_error(_(L("Empty layers detected, the output would not be printable.")) + "\n\n" + | ||||
|                     _(L("Object name: ")) + object.model_object()->name + "\n" + _(L("Print z: ")) + | ||||
|                     _(L("Object name")) + ": " + object.model_object()->name + "\n" + _(L("Print z")) + ": " + | ||||
|                     std::to_string(layers_to_print.back().print_z()) + "\n\n" + _(L("This is " | ||||
|                     "usually caused by negligibly small extrusions or by a faulty model. Try to repair " | ||||
|                     " the model or change its orientation on the bed."))); | ||||
|  | @ -695,7 +695,7 @@ std::vector<std::pair<coordf_t, std::vector<GCode::LayerToPrint>>> GCode::collec | |||
| } | ||||
| 
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| void GCode::do_export(Print* print, const char* path, GCodePreviewData* preview_data, const std::vector<ThumbnailData>* thumbnail_data) | ||||
| void GCode::do_export(Print* print, const char* path, GCodePreviewData* preview_data, ThumbnailsGeneratorCallback thumbnail_cb) | ||||
| #else | ||||
| void GCode::do_export(Print *print, const char *path, GCodePreviewData *preview_data) | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -725,7 +725,7 @@ void GCode::do_export(Print *print, const char *path, GCodePreviewData *preview_ | |||
|     try { | ||||
|         m_placeholder_parser_failed_templates.clear(); | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|         this->_do_export(*print, file, thumbnail_data); | ||||
|         this->_do_export(*print, file, thumbnail_cb); | ||||
| #else | ||||
|         this->_do_export(*print, file); | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -793,9 +793,9 @@ void GCode::do_export(Print *print, const char *path, GCodePreviewData *preview_ | |||
| } | ||||
| 
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| void GCode::_do_export(Print& print, FILE* file, const std::vector<ThumbnailData>* thumbnail_data) | ||||
| void GCode::_do_export(Print& print, FILE* file, ThumbnailsGeneratorCallback thumbnail_cb) | ||||
| #else | ||||
| void GCode::_do_export(Print &print, FILE *file) | ||||
| void GCode::_do_export(Print& print, FILE* file) | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| { | ||||
|     PROFILE_FUNC(); | ||||
|  | @ -803,6 +803,7 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|     // resets time estimators
 | ||||
|     m_normal_time_estimator.reset(); | ||||
|     m_normal_time_estimator.set_dialect(print.config().gcode_flavor); | ||||
|     m_normal_time_estimator.set_extrusion_axis(print.config().get_extrusion_axis()[0]); | ||||
|     m_silent_time_estimator_enabled = (print.config().gcode_flavor == gcfMarlin) && print.config().silent_mode; | ||||
| 
 | ||||
|     // Until we have a UI support for the other firmwares than the Marlin, use the hardcoded default values
 | ||||
|  | @ -812,46 +813,47 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|     // shall be adjusted as well to produce a G-code block compatible with the particular firmware flavor.
 | ||||
|     if (print.config().gcode_flavor.value == gcfMarlin) { | ||||
|         m_normal_time_estimator.set_max_acceleration((float)print.config().machine_max_acceleration_extruding.values[0]); | ||||
| 		m_normal_time_estimator.set_retract_acceleration((float)print.config().machine_max_acceleration_retracting.values[0]); | ||||
| 		m_normal_time_estimator.set_minimum_feedrate((float)print.config().machine_min_extruding_rate.values[0]); | ||||
| 		m_normal_time_estimator.set_minimum_travel_feedrate((float)print.config().machine_min_travel_rate.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::X, (float)print.config().machine_max_acceleration_x.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Y, (float)print.config().machine_max_acceleration_y.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Z, (float)print.config().machine_max_acceleration_z.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::E, (float)print.config().machine_max_acceleration_e.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::X, (float)print.config().machine_max_feedrate_x.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Y, (float)print.config().machine_max_feedrate_y.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Z, (float)print.config().machine_max_feedrate_z.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::E, (float)print.config().machine_max_feedrate_e.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::X, (float)print.config().machine_max_jerk_x.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Y, (float)print.config().machine_max_jerk_y.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Z, (float)print.config().machine_max_jerk_z.values[0]); | ||||
| 		m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::E, (float)print.config().machine_max_jerk_e.values[0]); | ||||
|         m_normal_time_estimator.set_retract_acceleration((float)print.config().machine_max_acceleration_retracting.values[0]); | ||||
|         m_normal_time_estimator.set_minimum_feedrate((float)print.config().machine_min_extruding_rate.values[0]); | ||||
|         m_normal_time_estimator.set_minimum_travel_feedrate((float)print.config().machine_min_travel_rate.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::X, (float)print.config().machine_max_acceleration_x.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Y, (float)print.config().machine_max_acceleration_y.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Z, (float)print.config().machine_max_acceleration_z.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::E, (float)print.config().machine_max_acceleration_e.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::X, (float)print.config().machine_max_feedrate_x.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Y, (float)print.config().machine_max_feedrate_y.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Z, (float)print.config().machine_max_feedrate_z.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::E, (float)print.config().machine_max_feedrate_e.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::X, (float)print.config().machine_max_jerk_x.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Y, (float)print.config().machine_max_jerk_y.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Z, (float)print.config().machine_max_jerk_z.values[0]); | ||||
|         m_normal_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::E, (float)print.config().machine_max_jerk_e.values[0]); | ||||
| 
 | ||||
|         if (m_silent_time_estimator_enabled) | ||||
|         { | ||||
|             m_silent_time_estimator.reset(); | ||||
|             m_silent_time_estimator.set_dialect(print.config().gcode_flavor); | ||||
|             /* "Stealth mode" values can be just a copy of "normal mode" values 
 | ||||
|             m_silent_time_estimator.set_extrusion_axis(print.config().get_extrusion_axis()[0]); | ||||
|             /* "Stealth mode" values can be just a copy of "normal mode" values
 | ||||
|             * (when they aren't input for a printer preset). | ||||
|             * Thus, use back value from values, instead of second one, which could be absent | ||||
|             */ | ||||
| 			m_silent_time_estimator.set_max_acceleration((float)print.config().machine_max_acceleration_extruding.values.back()); | ||||
| 			m_silent_time_estimator.set_retract_acceleration((float)print.config().machine_max_acceleration_retracting.values.back()); | ||||
| 			m_silent_time_estimator.set_minimum_feedrate((float)print.config().machine_min_extruding_rate.values.back()); | ||||
| 			m_silent_time_estimator.set_minimum_travel_feedrate((float)print.config().machine_min_travel_rate.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::X, (float)print.config().machine_max_acceleration_x.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Y, (float)print.config().machine_max_acceleration_y.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Z, (float)print.config().machine_max_acceleration_z.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::E, (float)print.config().machine_max_acceleration_e.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::X, (float)print.config().machine_max_feedrate_x.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Y, (float)print.config().machine_max_feedrate_y.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Z, (float)print.config().machine_max_feedrate_z.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::E, (float)print.config().machine_max_feedrate_e.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::X, (float)print.config().machine_max_jerk_x.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Y, (float)print.config().machine_max_jerk_y.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Z, (float)print.config().machine_max_jerk_z.values.back()); | ||||
| 			m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::E, (float)print.config().machine_max_jerk_e.values.back()); | ||||
|             m_silent_time_estimator.set_max_acceleration((float)print.config().machine_max_acceleration_extruding.values.back()); | ||||
|             m_silent_time_estimator.set_retract_acceleration((float)print.config().machine_max_acceleration_retracting.values.back()); | ||||
|             m_silent_time_estimator.set_minimum_feedrate((float)print.config().machine_min_extruding_rate.values.back()); | ||||
|             m_silent_time_estimator.set_minimum_travel_feedrate((float)print.config().machine_min_travel_rate.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::X, (float)print.config().machine_max_acceleration_x.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Y, (float)print.config().machine_max_acceleration_y.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::Z, (float)print.config().machine_max_acceleration_z.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_acceleration(GCodeTimeEstimator::E, (float)print.config().machine_max_acceleration_e.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::X, (float)print.config().machine_max_feedrate_x.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Y, (float)print.config().machine_max_feedrate_y.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::Z, (float)print.config().machine_max_feedrate_z.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_feedrate(GCodeTimeEstimator::E, (float)print.config().machine_max_feedrate_e.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::X, (float)print.config().machine_max_jerk_x.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Y, (float)print.config().machine_max_jerk_y.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::Z, (float)print.config().machine_max_jerk_z.values.back()); | ||||
|             m_silent_time_estimator.set_axis_max_jerk(GCodeTimeEstimator::E, (float)print.config().machine_max_jerk_e.values.back()); | ||||
|             if (print.config().single_extruder_multi_material) { | ||||
|                 // As of now the fields are shown at the UI dialog in the same combo box as the ramming values, so they
 | ||||
|                 // are considered to be active for the single extruder multi-material printers only.
 | ||||
|  | @ -881,6 +883,9 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|     } | ||||
|     m_analyzer.set_extruder_offsets(extruder_offsets); | ||||
| 
 | ||||
|     // tell analyzer about the extrusion axis
 | ||||
|     m_analyzer.set_extrusion_axis(print.config().get_extrusion_axis()[0]); | ||||
| 
 | ||||
|     // send extruders count to analyzer to allow it to detect invalid extruder idxs
 | ||||
|     const ConfigOptionStrings* extruders_opt = dynamic_cast<const ConfigOptionStrings*>(print.config().option("extruder_colour")); | ||||
|     const ConfigOptionStrings* filamemts_opt = dynamic_cast<const ConfigOptionStrings*>(print.config().option("filament_colour")); | ||||
|  | @ -909,7 +914,8 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|             std::sort(zs.begin(), zs.end()); | ||||
|             m_layer_count += (unsigned int)(object->copies().size() * (std::unique(zs.begin(), zs.end()) - zs.begin())); | ||||
|         } | ||||
|     } else { | ||||
|     } | ||||
|     else { | ||||
|         // Print all objects with the same print_z together.
 | ||||
|         std::vector<coordf_t> zs; | ||||
|         for (auto object : print.objects()) { | ||||
|  | @ -927,40 +933,41 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|     m_enable_cooling_markers = true; | ||||
|     this->apply_print_config(print.config()); | ||||
|     this->set_extruders(print.extruders()); | ||||
|      | ||||
|     // Initialize colorprint.
 | ||||
|     m_colorprint_heights = cast<float>(print.config().colorprint_heights.values); | ||||
| 
 | ||||
|     // Initialize custom gcode
 | ||||
|     Model* model = print.get_object(0)->model_object()->get_model(); | ||||
|     m_custom_g_code_heights = model->custom_gcode_per_height; | ||||
| 
 | ||||
|     // Initialize autospeed.
 | ||||
|     { | ||||
|         // get the minimum cross-section used in the print
 | ||||
|         std::vector<double> mm3_per_mm; | ||||
|         for (auto object : print.objects()) { | ||||
|             for (size_t region_id = 0; region_id < object->region_volumes.size(); ++ region_id) { | ||||
|             for (size_t region_id = 0; region_id < object->region_volumes.size(); ++region_id) { | ||||
|                 const PrintRegion* region = print.regions()[region_id]; | ||||
|                 for (auto layer : object->layers()) { | ||||
|                     const LayerRegion* layerm = layer->regions()[region_id]; | ||||
|                     if (region->config().get_abs_value("perimeter_speed"          ) == 0 ||  | ||||
|                         region->config().get_abs_value("small_perimeter_speed"    ) == 0 ||  | ||||
|                         region->config().get_abs_value("external_perimeter_speed" ) == 0 ||  | ||||
|                         region->config().get_abs_value("bridge_speed"             ) == 0) | ||||
|                     if (region->config().get_abs_value("perimeter_speed") == 0 || | ||||
|                         region->config().get_abs_value("small_perimeter_speed") == 0 || | ||||
|                         region->config().get_abs_value("external_perimeter_speed") == 0 || | ||||
|                         region->config().get_abs_value("bridge_speed") == 0) | ||||
|                         mm3_per_mm.push_back(layerm->perimeters.min_mm3_per_mm()); | ||||
|                     if (region->config().get_abs_value("infill_speed"             ) == 0 ||  | ||||
|                         region->config().get_abs_value("solid_infill_speed"       ) == 0 ||  | ||||
|                         region->config().get_abs_value("top_solid_infill_speed"   ) == 0 ||  | ||||
|                         region->config().get_abs_value("bridge_speed"             ) == 0) | ||||
|                     if (region->config().get_abs_value("infill_speed") == 0 || | ||||
|                         region->config().get_abs_value("solid_infill_speed") == 0 || | ||||
|                         region->config().get_abs_value("top_solid_infill_speed") == 0 || | ||||
|                         region->config().get_abs_value("bridge_speed") == 0) | ||||
|                         mm3_per_mm.push_back(layerm->fills.min_mm3_per_mm()); | ||||
|                 } | ||||
|             } | ||||
|             if (object->config().get_abs_value("support_material_speed"           ) == 0 ||  | ||||
|                 object->config().get_abs_value("support_material_interface_speed" ) == 0) | ||||
|             if (object->config().get_abs_value("support_material_speed") == 0 || | ||||
|                 object->config().get_abs_value("support_material_interface_speed") == 0) | ||||
|                 for (auto layer : object->support_layers()) | ||||
|                     mm3_per_mm.push_back(layer->support_fills.min_mm3_per_mm()); | ||||
|         } | ||||
|         print.throw_if_canceled(); | ||||
|         // filter out 0-width segments
 | ||||
|         mm3_per_mm.erase(std::remove_if(mm3_per_mm.begin(), mm3_per_mm.end(), [](double v) { return v < 0.000001; }), mm3_per_mm.end()); | ||||
|         if (! mm3_per_mm.empty()) { | ||||
|         if (!mm3_per_mm.empty()) { | ||||
|             // In order to honor max_print_speed we need to find a target volumetric
 | ||||
|             // speed that we can use throughout the print. So we define this target 
 | ||||
|             // volumetric speed as the volumetric speed produced by printing the 
 | ||||
|  | @ -973,7 +980,7 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|         } | ||||
|     } | ||||
|     print.throw_if_canceled(); | ||||
|      | ||||
| 
 | ||||
|     m_cooling_buffer = make_unique<CoolingBuffer>(*this); | ||||
|     if (print.config().spiral_vase.value) | ||||
|         m_spiral_vase = make_unique<SpiralVase>(print.config()); | ||||
|  | @ -991,15 +998,15 @@ void GCode::_do_export(Print &print, FILE *file) | |||
| 
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|     // Write thumbnails using base64 encoding
 | ||||
|     if (thumbnail_data != nullptr) | ||||
|     if (thumbnail_cb != nullptr) | ||||
|     { | ||||
|         const size_t max_row_length = 78; | ||||
| 
 | ||||
|         for (const ThumbnailData& data : *thumbnail_data) | ||||
|         ThumbnailsList thumbnails; | ||||
|         thumbnail_cb(thumbnails, print.full_print_config().option<ConfigOptionPoints>("thumbnails")->values, true, true, true, true); | ||||
|         for (const ThumbnailData& data : thumbnails) | ||||
|         { | ||||
|             if (data.is_valid()) | ||||
|             { | ||||
| #if ENABLE_THUMBNAIL_GENERATOR_PNG_TO_GCODE | ||||
|                 size_t png_size = 0; | ||||
|                 void* png_data = tdefl_write_image_to_png_file_in_memory_ex((const void*)data.pixels.data(), data.width, data.height, 4, &png_size, MZ_DEFAULT_LEVEL, 1); | ||||
|                 if (png_data != nullptr) | ||||
|  | @ -1025,39 +1032,6 @@ void GCode::_do_export(Print &print, FILE *file) | |||
| 
 | ||||
|                     mz_free(png_data); | ||||
|                 } | ||||
| #else | ||||
|                 _write_format(file, "\n;\n; thumbnail begin %dx%d\n", data.width, data.height); | ||||
| 
 | ||||
|                 size_t row_size = 4 * data.width; | ||||
|                 for (int r = (int)data.height - 1; r >= 0; --r) | ||||
|                 { | ||||
|                     std::string encoded; | ||||
|                     encoded.resize(boost::beast::detail::base64::encoded_size(row_size)); | ||||
|                     encoded.resize(boost::beast::detail::base64::encode((void*)&encoded[0], (const void*)(data.pixels.data() + r * row_size), row_size)); | ||||
| 
 | ||||
|                     unsigned int row_count = 0; | ||||
|                     while (encoded.size() > max_row_length) | ||||
|                     { | ||||
|                         if (row_count == 0) | ||||
|                             _write_format(file, "; %s\n", encoded.substr(0, max_row_length).c_str()); | ||||
|                         else | ||||
|                             _write_format(file, ";>%s\n", encoded.substr(0, max_row_length).c_str()); | ||||
| 
 | ||||
|                         encoded = encoded.substr(max_row_length); | ||||
|                         ++row_count; | ||||
|                     } | ||||
| 
 | ||||
|                     if (encoded.size() > 0) | ||||
|                     { | ||||
|                         if (row_count == 0) | ||||
|                             _write_format(file, "; %s\n", encoded.c_str()); | ||||
|                         else | ||||
|                             _write_format(file, ";>%s\n", encoded.c_str()); | ||||
|                     } | ||||
|                 } | ||||
| 
 | ||||
|                 _write(file, "; thumbnail end\n;\n"); | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR_PNG_TO_GCODE
 | ||||
|             } | ||||
|             print.throw_if_canceled(); | ||||
|         } | ||||
|  | @ -1150,6 +1124,47 @@ void GCode::_do_export(Print &print, FILE *file) | |||
|     } | ||||
|     print.throw_if_canceled(); | ||||
| 
 | ||||
|     /* To avoid change filament for non-used extruder for Multi-material,
 | ||||
|      * check model->custom_gcode_per_height using tool_ordering values | ||||
|      * */ | ||||
|     if (!m_custom_g_code_heights. empty()) | ||||
|     { | ||||
|         bool delete_executed = false; | ||||
|         auto it = m_custom_g_code_heights.end(); | ||||
|         while (it != m_custom_g_code_heights.begin()) | ||||
|         { | ||||
|             --it; | ||||
|             if (it->gcode != ColorChangeCode) | ||||
|                 continue; | ||||
| 
 | ||||
|             auto it_layer_tools = std::lower_bound(tool_ordering.begin(), tool_ordering.end(), LayerTools(it->height)); | ||||
| 
 | ||||
|             bool used_extruder = false; | ||||
|             for (; it_layer_tools != tool_ordering.end(); it_layer_tools++) | ||||
|             { | ||||
|                 const std::vector<unsigned>& extruders = it_layer_tools->extruders; | ||||
|                 if (std::find(extruders.begin(), extruders.end(), (unsigned)(it->extruder-1)) != extruders.end()) | ||||
|                 { | ||||
|                     used_extruder = true; | ||||
|                     break; | ||||
|                 } | ||||
|             } | ||||
|             if (used_extruder) | ||||
|                 continue; | ||||
| 
 | ||||
|             /* If we are there, current extruder wouldn't be used,
 | ||||
|              * so this color change is a redundant move. | ||||
|              * Delete this item from m_custom_g_code_heights | ||||
|              * */ | ||||
|             it = m_custom_g_code_heights.erase(it); | ||||
|             delete_executed = true; | ||||
|         } | ||||
| 
 | ||||
|         if (delete_executed) | ||||
|             model->custom_gcode_per_height = m_custom_g_code_heights; | ||||
|     } | ||||
| 
 | ||||
| 
 | ||||
|     m_cooling_buffer->set_current_extruder(initial_extruder_id); | ||||
| 
 | ||||
|     // Emit machine envelope limits for the Marlin firmware.
 | ||||
|  | @ -1816,19 +1831,66 @@ void GCode::process_layer( | |||
|     // In case there are more toolchange requests that weren't done yet and should happen simultaneously, erase them all.
 | ||||
|     // (Layers can be close to each other, model could have been resliced with bigger layer height, ...).
 | ||||
|     bool colorprint_change = false; | ||||
|     while (!m_colorprint_heights.empty() && m_colorprint_heights.front()-EPSILON < layer.print_z) { | ||||
|         m_colorprint_heights.erase(m_colorprint_heights.begin()); | ||||
| 
 | ||||
|     std::string custom_code = ""; | ||||
|     std::string pause_print_msg = ""; | ||||
|     int m600_before_extruder = -1; | ||||
|     while (!m_custom_g_code_heights.empty() && m_custom_g_code_heights.front().height-EPSILON < layer.print_z) { | ||||
|         custom_code = m_custom_g_code_heights.front().gcode; | ||||
| 
 | ||||
|         if (custom_code == ColorChangeCode && m_custom_g_code_heights.front().extruder > 0) | ||||
|             m600_before_extruder = m_custom_g_code_heights.front().extruder - 1; | ||||
|         if (custom_code == PausePrintCode) | ||||
|             pause_print_msg = m_custom_g_code_heights.front().color; | ||||
| 
 | ||||
|         m_custom_g_code_heights.erase(m_custom_g_code_heights.begin()); | ||||
|         colorprint_change = true; | ||||
|     } | ||||
| 
 | ||||
|     // we should add or not colorprint_change in respect to nozzle_diameter count instead of really used extruders count
 | ||||
|     if (colorprint_change && print./*extruders()*/config().nozzle_diameter.size()==1) | ||||
|     { | ||||
|         // add tag for analyzer
 | ||||
|         gcode += "; " + GCodeAnalyzer::Color_Change_Tag + "\n"; | ||||
|         // add tag for time estimator
 | ||||
|         gcode += "; " + GCodeTimeEstimator::Color_Change_Tag + "\n"; | ||||
|         gcode += "M600\n"; | ||||
| 
 | ||||
|     // don't save "tool_change"(ExtruderChangeCode) code to GCode
 | ||||
|     if (colorprint_change && custom_code != ExtruderChangeCode) { | ||||
|         const bool single_material_print = print.config().nozzle_diameter.size() == 1; | ||||
|          | ||||
|         if (custom_code == ColorChangeCode) // color change
 | ||||
|         { | ||||
|             // add tag for analyzer
 | ||||
|             gcode += "; " + GCodeAnalyzer::Color_Change_Tag + ",T" + std::to_string(m600_before_extruder) + "\n"; | ||||
|             // add tag for time estimator
 | ||||
|             gcode += "; " + GCodeTimeEstimator::Color_Change_Tag + "\n"; | ||||
| 
 | ||||
|             if (!single_material_print && m600_before_extruder >= 0 && first_extruder_id != m600_before_extruder | ||||
|                 // && !MMU1
 | ||||
|                 ) { | ||||
|                 //! FIXME_in_fw show message during print pause
 | ||||
|                 gcode += "M601\n"; // pause print
 | ||||
|                 gcode += "M117 Change filament for Extruder " + std::to_string(m600_before_extruder) + "\n"; | ||||
|             } | ||||
|             else  | ||||
|                 gcode += custom_code + "\n"; | ||||
|         }  | ||||
|         else | ||||
|         { | ||||
|             if (custom_code == PausePrintCode) // Pause print
 | ||||
|             { | ||||
|                 // add tag for analyzer
 | ||||
|                 gcode += "; " + GCodeAnalyzer::Pause_Print_Tag + "\n"; | ||||
|                 //! FIXME_in_fw show message during print pause
 | ||||
|                 if (!pause_print_msg.empty()) | ||||
|                     gcode += "M117 " + pause_print_msg + "\n"; | ||||
|                 // add tag for time estimator
 | ||||
|                 //gcode += "; " + GCodeTimeEstimator::Pause_Print_Tag + "\n";
 | ||||
|             } | ||||
|             else // custom Gcode
 | ||||
|             { | ||||
|                 // add tag for analyzer
 | ||||
|                 gcode += "; " + GCodeAnalyzer::Custom_Code_Tag + "\n"; | ||||
|                 // add tag for time estimator
 | ||||
|                 //gcode += "; " + GCodeTimeEstimator::Custom_Code_Tag + "\n";
 | ||||
|             } | ||||
|             gcode += custom_code + "\n"; | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
| 
 | ||||
|  | @ -2138,6 +2200,12 @@ void GCode::process_layer( | |||
|     if (m_cooling_buffer) | ||||
|         gcode = m_cooling_buffer->process_layer(gcode, layer.id()); | ||||
| 
 | ||||
|     // add tag for analyzer
 | ||||
|     if (gcode.find(GCodeAnalyzer::Pause_Print_Tag) != gcode.npos) | ||||
|         gcode += "\n; " + GCodeAnalyzer::End_Pause_Print_Or_Custom_Code_Tag + "\n"; | ||||
|     else if (gcode.find(GCodeAnalyzer::Custom_Code_Tag) != gcode.npos) | ||||
|         gcode += "\n; " + GCodeAnalyzer::End_Pause_Print_Or_Custom_Code_Tag + "\n"; | ||||
| 
 | ||||
| #ifdef HAS_PRESSURE_EQUALIZER | ||||
|     // Apply pressure equalization if enabled;
 | ||||
|     // printf("G-code before filter:\n%s\n", gcode.c_str());
 | ||||
|  |  | |||
|  | @ -17,6 +17,9 @@ | |||
| #include "GCodeTimeEstimator.hpp" | ||||
| #include "EdgeGrid.hpp" | ||||
| #include "GCode/Analyzer.hpp" | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| #include "GCode/ThumbnailData.hpp" | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| 
 | ||||
| #include <memory> | ||||
| #include <string> | ||||
|  | @ -30,9 +33,6 @@ namespace Slic3r { | |||
| // Forward declarations.
 | ||||
| class GCode; | ||||
| class GCodePreviewData; | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| struct ThumbnailData; | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| 
 | ||||
| class AvoidCrossingPerimeters { | ||||
| public: | ||||
|  | @ -167,7 +167,7 @@ public: | |||
|     // throws std::runtime_exception on error,
 | ||||
|     // throws CanceledException through print->throw_if_canceled().
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|     void            do_export(Print* print, const char* path, GCodePreviewData* preview_data = nullptr, const std::vector<ThumbnailData>* thumbnail_data = nullptr); | ||||
|     void            do_export(Print* print, const char* path, GCodePreviewData* preview_data = nullptr, ThumbnailsGeneratorCallback thumbnail_cb = nullptr); | ||||
| #else | ||||
|     void            do_export(Print *print, const char *path, GCodePreviewData *preview_data = nullptr); | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -199,7 +199,7 @@ public: | |||
| 
 | ||||
| protected: | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|     void            _do_export(Print& print, FILE* file, const std::vector<ThumbnailData>* thumbnail_data); | ||||
|     void            _do_export(Print& print, FILE* file, ThumbnailsGeneratorCallback thumbnail_cb); | ||||
| #else | ||||
|     void            _do_export(Print &print, FILE *file); | ||||
| #endif //ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -362,9 +362,12 @@ protected: | |||
|     bool                                m_second_layer_things_done; | ||||
|     // Index of a last object copy extruded.
 | ||||
|     std::pair<const PrintObject*, Point> m_last_obj_copy; | ||||
|     // Layer heights for colorprint - updated before the export and erased during the process
 | ||||
|     // so no toolchange occurs twice.
 | ||||
|     std::vector<float> m_colorprint_heights; | ||||
|     /* Extensions for colorprint - now it's not a just color_print_heights, 
 | ||||
|      * there can be some custom gcode. | ||||
|      * Updated before the export and erased during the process, | ||||
|      * so no toolchange occurs twice. | ||||
|      * */ | ||||
|     std::vector<Model::CustomGCode> m_custom_g_code_heights; | ||||
| 
 | ||||
|     // Time estimators
 | ||||
|     GCodeTimeEstimator m_normal_time_estimator; | ||||
|  |  | |||
|  | @ -29,6 +29,9 @@ const std::string GCodeAnalyzer::Mm3_Per_Mm_Tag = "_ANALYZER_MM3_PER_MM:"; | |||
| const std::string GCodeAnalyzer::Width_Tag = "_ANALYZER_WIDTH:"; | ||||
| const std::string GCodeAnalyzer::Height_Tag = "_ANALYZER_HEIGHT:"; | ||||
| const std::string GCodeAnalyzer::Color_Change_Tag = "_ANALYZER_COLOR_CHANGE"; | ||||
| const std::string GCodeAnalyzer::Pause_Print_Tag = "_ANALYZER_PAUSE_PRINT"; | ||||
| const std::string GCodeAnalyzer::Custom_Code_Tag = "_ANALYZER_CUSTOM_CODE"; | ||||
| const std::string GCodeAnalyzer::End_Pause_Print_Or_Custom_Code_Tag = "_ANALYZER_END_PAUSE_PRINT_OR_CUSTOM_CODE"; | ||||
| 
 | ||||
| const double GCodeAnalyzer::Default_mm3_per_mm = 0.0; | ||||
| const float GCodeAnalyzer::Default_Width = 0.0f; | ||||
|  | @ -105,24 +108,11 @@ GCodeAnalyzer::GCodeMove::GCodeMove(GCodeMove::EType type, const GCodeAnalyzer:: | |||
| { | ||||
| } | ||||
| 
 | ||||
| GCodeAnalyzer::GCodeAnalyzer() | ||||
| { | ||||
|     reset(); | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::set_extruder_offsets(const GCodeAnalyzer::ExtruderOffsetsMap& extruder_offsets) | ||||
| { | ||||
|     m_extruder_offsets = extruder_offsets; | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::set_extruders_count(unsigned int count) | ||||
| { | ||||
|     m_extruders_count = count; | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::set_gcode_flavor(const GCodeFlavor& flavor) | ||||
| { | ||||
|     m_gcode_flavor = flavor; | ||||
|     for (unsigned int i=0; i<m_extruders_count; i++) | ||||
|         m_extruder_color[i] = i; | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::reset() | ||||
|  | @ -147,6 +137,7 @@ void GCodeAnalyzer::reset() | |||
|     m_moves_map.clear(); | ||||
|     m_extruder_offsets.clear(); | ||||
|     m_extruders_count = 1; | ||||
|     m_extruder_color.clear(); | ||||
| } | ||||
| 
 | ||||
| const std::string& GCodeAnalyzer::process_gcode(const std::string& gcode) | ||||
|  | @ -595,7 +586,11 @@ void GCodeAnalyzer::_processT(const std::string& cmd) | |||
|                     BOOST_LOG_TRIVIAL(error) << "GCodeAnalyzer encountered an invalid toolchange, maybe from a custom gcode."; | ||||
|             } | ||||
|             else | ||||
|             { | ||||
|                 _set_extruder_id(id); | ||||
|                 if (_get_cp_color_id() != INT_MAX) | ||||
|                     _set_cp_color_id(m_extruder_color[id]); | ||||
|             } | ||||
| 
 | ||||
|             // stores tool change move
 | ||||
|             _store_move(GCodeMove::Tool_change); | ||||
|  | @ -648,7 +643,33 @@ bool GCodeAnalyzer::_process_tags(const GCodeReader::GCodeLine& line) | |||
|     pos = comment.find(Color_Change_Tag); | ||||
|     if (pos != comment.npos) | ||||
|     { | ||||
|         _process_color_change_tag(); | ||||
|         pos = comment.find_last_of(",T"); | ||||
|         int extruder = pos == comment.npos ? 0 : std::atoi(comment.substr(pos + 1, comment.npos).c_str()); | ||||
|         _process_color_change_tag(extruder); | ||||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|     // color change tag
 | ||||
|     pos = comment.find(Pause_Print_Tag); | ||||
|     if (pos != comment.npos) | ||||
|     { | ||||
|         _process_pause_print_or_custom_code_tag(); | ||||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|     // color change tag
 | ||||
|     pos = comment.find(Custom_Code_Tag); | ||||
|     if (pos != comment.npos) | ||||
|     { | ||||
|         _process_pause_print_or_custom_code_tag(); | ||||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|     // color change tag
 | ||||
|     pos = comment.find(End_Pause_Print_Or_Custom_Code_Tag); | ||||
|     if (pos != comment.npos) | ||||
|     { | ||||
|         _process_end_pause_print_or_custom_code_tag(); | ||||
|         return true; | ||||
|     } | ||||
| 
 | ||||
|  | @ -681,10 +702,24 @@ void GCodeAnalyzer::_process_height_tag(const std::string& comment, size_t pos) | |||
|     _set_height((float)::strtod(comment.substr(pos + Height_Tag.length()).c_str(), nullptr)); | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::_process_color_change_tag() | ||||
| void GCodeAnalyzer::_process_color_change_tag(int extruder) | ||||
| { | ||||
|     m_state.cur_cp_color_id++; | ||||
|     _set_cp_color_id(m_state.cur_cp_color_id); | ||||
|     m_extruder_color[extruder] = m_extruders_count + m_state.cp_color_counter; // color_change position in list of color for preview
 | ||||
|     m_state.cp_color_counter++; | ||||
| 
 | ||||
|     if (_get_extruder_id() == extruder) | ||||
|         _set_cp_color_id(m_extruder_color[extruder]); | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::_process_pause_print_or_custom_code_tag() | ||||
| { | ||||
|     _set_cp_color_id(INT_MAX); | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::_process_end_pause_print_or_custom_code_tag() | ||||
| { | ||||
|     if (_get_cp_color_id() == INT_MAX) | ||||
|         _set_cp_color_id(m_extruder_color[_get_extruder_id()]); | ||||
| } | ||||
| 
 | ||||
| void GCodeAnalyzer::_set_units(GCodeAnalyzer::EUnits units) | ||||
|  |  | |||
|  | @ -20,6 +20,9 @@ public: | |||
|     static const std::string Width_Tag; | ||||
|     static const std::string Height_Tag; | ||||
|     static const std::string Color_Change_Tag; | ||||
|     static const std::string Pause_Print_Tag; | ||||
|     static const std::string Custom_Code_Tag; | ||||
|     static const std::string End_Pause_Print_Or_Custom_Code_Tag; | ||||
| 
 | ||||
|     static const double Default_mm3_per_mm; | ||||
|     static const float Default_Width; | ||||
|  | @ -89,6 +92,7 @@ public: | |||
|     typedef std::vector<GCodeMove> GCodeMovesList; | ||||
|     typedef std::map<GCodeMove::EType, GCodeMovesList> TypeToMovesMap; | ||||
|     typedef std::map<unsigned int, Vec2d> ExtruderOffsetsMap; | ||||
|     typedef std::map<unsigned int, unsigned int> ExtruderToColorMap; | ||||
| 
 | ||||
| private: | ||||
|     struct State | ||||
|  | @ -102,7 +106,7 @@ private: | |||
|         float start_extrusion; | ||||
|         float position[Num_Axis]; | ||||
|         float origin[Num_Axis]; | ||||
|         unsigned int cur_cp_color_id = 0; | ||||
|         unsigned int cp_color_counter = 0; | ||||
|     }; | ||||
| 
 | ||||
| private: | ||||
|  | @ -113,16 +117,20 @@ private: | |||
|     unsigned int m_extruders_count; | ||||
|     GCodeFlavor m_gcode_flavor; | ||||
| 
 | ||||
|     ExtruderToColorMap m_extruder_color; | ||||
| 
 | ||||
|     // The output of process_layer()
 | ||||
|     std::string m_process_output; | ||||
| 
 | ||||
| public: | ||||
|     GCodeAnalyzer(); | ||||
|     GCodeAnalyzer() { reset(); } | ||||
| 
 | ||||
|     void set_extruder_offsets(const ExtruderOffsetsMap& extruder_offsets); | ||||
|     void set_extruder_offsets(const ExtruderOffsetsMap& extruder_offsets) { m_extruder_offsets = extruder_offsets; } | ||||
|     void set_extruders_count(unsigned int count); | ||||
| 
 | ||||
|     void set_gcode_flavor(const GCodeFlavor& flavor); | ||||
|     void set_extrusion_axis(char axis) { m_parser.set_extrusion_axis(axis); } | ||||
| 
 | ||||
|     void set_gcode_flavor(const GCodeFlavor& flavor) { m_gcode_flavor = flavor; } | ||||
| 
 | ||||
|     // Reinitialize the analyzer
 | ||||
|     void reset(); | ||||
|  | @ -212,7 +220,13 @@ private: | |||
|     void _process_height_tag(const std::string& comment, size_t pos); | ||||
| 
 | ||||
|     // Processes color change tag
 | ||||
|     void _process_color_change_tag(); | ||||
|     void _process_color_change_tag(int extruder); | ||||
| 
 | ||||
|     // Processes pause print and custom gcode tag
 | ||||
|     void _process_pause_print_or_custom_code_tag(); | ||||
| 
 | ||||
|     // Processes new layer tag
 | ||||
|     void _process_end_pause_print_or_custom_code_tag(); | ||||
| 
 | ||||
|     void _set_units(EUnits units); | ||||
|     EUnits _get_units() const; | ||||
|  |  | |||
|  | @ -379,7 +379,8 @@ std::string GCodePreviewData::get_legend_title() const | |||
|     return ""; | ||||
| } | ||||
| 
 | ||||
| GCodePreviewData::LegendItemsList GCodePreviewData::get_legend_items(const std::vector<float>& tool_colors, const std::vector</*double*/std::pair<double, double>>& cp_values) const | ||||
| GCodePreviewData::LegendItemsList GCodePreviewData::get_legend_items(const std::vector<float>& tool_colors,  | ||||
|                                                                      const std::vector<std::string>& cp_items) const | ||||
| { | ||||
|     struct Helper | ||||
|     { | ||||
|  | @ -455,31 +456,25 @@ GCodePreviewData::LegendItemsList GCodePreviewData::get_legend_items(const std:: | |||
|     case Extrusion::ColorPrint: | ||||
|         { | ||||
|             const int color_cnt = (int)tool_colors.size()/4; | ||||
| 
 | ||||
|             const auto color_print_cnt = (int)cp_values.size(); | ||||
|             for (int i = color_print_cnt; i >= 0 ; --i) | ||||
|             const auto color_print_cnt = (int)cp_items.size(); | ||||
|             if (color_print_cnt == 1) // means "Default print color"
 | ||||
|             { | ||||
|                 GCodePreviewData::Color color; | ||||
|                 ::memcpy((void*)color.rgba, (const void*)(tool_colors.data() + (i % color_cnt) * 4), 4 * sizeof(float)); | ||||
|                 Color color; | ||||
|                 ::memcpy((void*)color.rgba, (const void*)(tool_colors.data()), 4 * sizeof(float)); | ||||
| 
 | ||||
|                 items.emplace_back(cp_items[0], color); | ||||
|                 break; | ||||
|             } | ||||
| 
 | ||||
|             if (color_cnt != color_print_cnt) | ||||
|                 break; | ||||
| 
 | ||||
|             for (int i = 0 ; i < color_print_cnt; ++i) | ||||
|             { | ||||
|                 Color color; | ||||
|                 ::memcpy((void*)color.rgba, (const void*)(tool_colors.data() + i * 4), 4 * sizeof(float)); | ||||
|                  | ||||
|                 if (color_print_cnt == 0) { | ||||
|                     items.emplace_back(Slic3r::I18N::translate(L("Default print color")), color); | ||||
|                     break; | ||||
|                 } | ||||
| 
 | ||||
|                 std::string id_str = std::to_string(i + 1) + ": "; | ||||
| 
 | ||||
|                 if (i == 0) { | ||||
|                     items.emplace_back(id_str + (boost::format(Slic3r::I18N::translate(L("up to %.2f mm"))) % cp_values[0].first).str(), color); | ||||
|                     break; | ||||
|                 } | ||||
|                 if (i == color_print_cnt) { | ||||
|                     items.emplace_back(id_str + (boost::format(Slic3r::I18N::translate(L("above %.2f mm"))) % cp_values[i - 1].second).str(), color); | ||||
|                     continue; | ||||
|                 } | ||||
| 
 | ||||
| //                 items.emplace_back((boost::format(Slic3r::I18N::translate(L("%.2f - %.2f mm"))) %  cp_values[i-1] % cp_values[i]).str(), color);
 | ||||
|                 items.emplace_back(id_str + (boost::format(Slic3r::I18N::translate(L("%.2f - %.2f mm"))) % cp_values[i - 1].second% cp_values[i].first).str(), color); | ||||
|                 items.emplace_back(cp_items[i], color); | ||||
|             } | ||||
|             break; | ||||
|         } | ||||
|  |  | |||
|  | @ -237,7 +237,7 @@ public: | |||
|     void set_extrusion_paths_colors(const std::vector<std::string>& colors); | ||||
| 
 | ||||
|     std::string get_legend_title() const; | ||||
|     LegendItemsList get_legend_items(const std::vector<float>& tool_colors, const std::vector</*double*/std::pair<double, double>>& cp_values) const; | ||||
|     LegendItemsList get_legend_items(const std::vector<float>& tool_colors, const std::vector<std::string>& cp_items) const; | ||||
| 
 | ||||
|     // Return an estimate of the memory consumed by the time estimator.
 | ||||
|     size_t memory_used() const; | ||||
|  |  | |||
|  | @ -4,6 +4,7 @@ | |||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| 
 | ||||
| #include <vector> | ||||
| #include "libslic3r/Point.hpp" | ||||
| 
 | ||||
| namespace Slic3r { | ||||
| 
 | ||||
|  | @ -20,6 +21,9 @@ struct ThumbnailData | |||
|     bool is_valid() const; | ||||
| }; | ||||
| 
 | ||||
| typedef std::vector<ThumbnailData> ThumbnailsList; | ||||
| typedef std::function<void(ThumbnailsList & thumbnails, const Vec2ds & sizes, bool printable_only, bool parts_only, bool show_bed, bool transparent_background)> ThumbnailsGeneratorCallback; | ||||
| 
 | ||||
| } // namespace Slic3r
 | ||||
| 
 | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  |  | |||
|  | @ -1004,9 +1004,10 @@ void WipeTower::toolchange_Change( | |||
|     writer.append("[toolchange_gcode]\n"); | ||||
| 
 | ||||
|     // Travel to where we assume we are. Custom toolchange or some special T code handling (parking extruder etc)
 | ||||
|     // gcode could have left the extruder somewhere, we cannot just start extruding.
 | ||||
| 	Vec2f current_pos = writer.pos_rotated(); | ||||
|     writer.append(std::string("G1 X") + std::to_string(current_pos.x()) +  " Y" + std::to_string(current_pos.y()) +  "\n"); | ||||
|     // gcode could have left the extruder somewhere, we cannot just start extruding. We should also inform the
 | ||||
|     // postprocessor that we absolutely want to have this in the gcode, even if it thought it is the same as before.
 | ||||
|     Vec2f current_pos = writer.pos_rotated(); | ||||
|     writer.append(std::string("G1 X") + std::to_string(current_pos.x()) +  " Y" + std::to_string(current_pos.y()) + never_skip_tag() + "\n"); | ||||
| 
 | ||||
|     // The toolchange Tn command will be inserted later, only in case that the user does
 | ||||
|     // not provide a custom toolchange gcode.
 | ||||
|  |  | |||
|  | @ -17,9 +17,12 @@ class PrintConfig; | |||
| enum GCodeFlavor : unsigned char; | ||||
| 
 | ||||
| 
 | ||||
| 
 | ||||
| class WipeTower | ||||
| { | ||||
| public: | ||||
|     static char const* never_skip_tag() { return "_GCODE_WIPE_TOWER_NEVER_SKIP_TAG"; } | ||||
| 
 | ||||
|     struct Extrusion | ||||
|     { | ||||
| 		Extrusion(const Vec2f &pos, float width, unsigned int tool) : pos(pos), width(width), tool(tool) {} | ||||
|  | @ -96,6 +99,8 @@ public: | |||
| 
 | ||||
| 
 | ||||
| 
 | ||||
| 
 | ||||
| 
 | ||||
| 	// Switch to a next layer.
 | ||||
| 	void set_layer( | ||||
| 		// Print height of this layer.
 | ||||
|  |  | |||
|  | @ -119,6 +119,7 @@ public: | |||
|     float  f() const { return m_position[F]; } | ||||
| 
 | ||||
|     char   extrusion_axis() const { return m_extrusion_axis; } | ||||
|     void   set_extrusion_axis(char axis) { m_extrusion_axis = axis; } | ||||
| 
 | ||||
| private: | ||||
|     const char* parse_line_internal(const char *ptr, GCodeLine &gline, std::pair<const char*, const char*> &command); | ||||
|  |  | |||
|  | @ -342,6 +342,8 @@ namespace Slic3r { | |||
|         void increment_g1_line_id(); | ||||
|         void reset_g1_line_id(); | ||||
| 
 | ||||
|         void set_extrusion_axis(char axis) { m_parser.set_extrusion_axis(axis); } | ||||
| 
 | ||||
|         void set_extruder_id(unsigned int id); | ||||
|         unsigned int get_extruder_id() const; | ||||
|         void reset_extruder_id(); | ||||
|  |  | |||
|  | @ -137,6 +137,79 @@ inline bool segments_intersect( | |||
| 		   segments_could_intersect(jp1, jp2, ip1, ip2) <= 0; | ||||
| } | ||||
| 
 | ||||
| // Based on Liang-Barsky function by Daniel White @ http://www.skytopia.com/project/articles/compsci/clipping.html
 | ||||
| template<typename T> | ||||
| bool liang_barsky_line_clipping( | ||||
| 	// Start and end points of the source line, result will be stored there as well.
 | ||||
| 	Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 						&x0, | ||||
| 	Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 						&x1, | ||||
| 	// Bounding box to clip with.
 | ||||
| 	const BoundingBoxBase<Eigen::Matrix<T, 2, 1, Eigen::DontAlign>> &bbox) | ||||
| { | ||||
|     Eigen::Matrix<T, 2, 1, Eigen::DontAlign> v = x1 - x0; | ||||
|     double t0 = 0.0; | ||||
|     double t1 = 1.0; | ||||
| 
 | ||||
| 	// Traverse through left, right, bottom, top edges.
 | ||||
|     for (int edge = 0; edge < 4; ++ edge) | ||||
|     { | ||||
| 		double p, q; | ||||
|     	switch (edge) { | ||||
|     	case 0:	 p = - v.x();    q = - bbox.min.x() + x0.x();	break; | ||||
|         case 1:  p =   v.x();    q =   bbox.max.x() - x0.x();	break; | ||||
|         case 2:  p = - v.y();    q = - bbox.min.y() + x0.y();	break; | ||||
|         default: p =   v.y();    q =   bbox.max.y() - x0.y();   break; | ||||
|     	} | ||||
|          | ||||
| 		if (p == 0) { | ||||
| 			if (q < 0) | ||||
| 				// Line parallel to the bounding box edge is fully outside of the bounding box.
 | ||||
| 				return false; | ||||
| 			// else don't clip
 | ||||
| 		} else { | ||||
| 	        double r = q / p; | ||||
| 			if (p < 0) { | ||||
| 				if (r > t1) | ||||
|             		// Fully clipped.
 | ||||
|             		return false; | ||||
| 				if (r > t0) | ||||
|             		// Partially clipped.
 | ||||
|             		t0 = r; | ||||
| 			} else { | ||||
| 				assert(p > 0); | ||||
| 				if (r < t0) | ||||
|             		// Fully clipped.
 | ||||
|             		return false; | ||||
| 				if (r < t1) | ||||
|             		// Partially clipped.
 | ||||
|             		t1 = r; | ||||
| 			} | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
|     // Clipped successfully.
 | ||||
|     x1  = x0 + t1 * v; | ||||
|     x0 += t0 * v; | ||||
|     return true; | ||||
| } | ||||
| 
 | ||||
| // Based on Liang-Barsky function by Daniel White @ http://www.skytopia.com/project/articles/compsci/clipping.html
 | ||||
| template<typename T> | ||||
| bool liang_barsky_line_clipping( | ||||
| 	// Start and end points of the source line.
 | ||||
| 	const Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 					&x0src, | ||||
| 	const Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 					&x1src, | ||||
| 	// Bounding box to clip with.
 | ||||
| 	const BoundingBoxBase<Eigen::Matrix<T, 2, 1, Eigen::DontAlign>> &bbox, | ||||
| 	// Start and end points of the clipped line.
 | ||||
| 	Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 						&x0clip, | ||||
| 	Eigen::Matrix<T, 2, 1, Eigen::DontAlign> 						&x1clip) | ||||
| { | ||||
| 	x0clip = x0src; | ||||
| 	x1clip = x1src; | ||||
| 	return liang_barsky_line_clipping(x0clip, x1clip, bbox); | ||||
| } | ||||
| 
 | ||||
| Pointf3s convex_hull(Pointf3s points); | ||||
| Polygon convex_hull(Points points); | ||||
| Polygon convex_hull(const Polygons &polygons); | ||||
|  |  | |||
|  | @ -107,6 +107,17 @@ bool Line::intersection(const Line &l2, Point *intersection) const | |||
|     return false;  // not intersecting
 | ||||
| } | ||||
| 
 | ||||
| bool Line::clip_with_bbox(const BoundingBox &bbox) | ||||
| { | ||||
| 	Vec2d x0clip, x1clip; | ||||
| 	bool result = Geometry::liang_barsky_line_clipping<double>(this->a.cast<double>(), this->b.cast<double>(), BoundingBoxf(bbox.min.cast<double>(), bbox.max.cast<double>()), x0clip, x1clip); | ||||
| 	if (result) { | ||||
| 		this->a = x0clip.cast<coord_t>(); | ||||
| 		this->b = x1clip.cast<coord_t>(); | ||||
| 	} | ||||
| 	return result; | ||||
| } | ||||
| 
 | ||||
| Vec3d Linef3::intersect_plane(double z) const | ||||
| { | ||||
|     auto   v = (this->b - this->a).cast<double>(); | ||||
|  |  | |||
|  | @ -6,6 +6,7 @@ | |||
| 
 | ||||
| namespace Slic3r { | ||||
| 
 | ||||
| class BoundingBox; | ||||
| class Line; | ||||
| class Line3; | ||||
| class Linef3; | ||||
|  | @ -43,6 +44,8 @@ public: | |||
|     Vector normal() const { return Vector((this->b(1) - this->a(1)), -(this->b(0) - this->a(0))); } | ||||
|     bool   intersection(const Line& line, Point* intersection) const; | ||||
|     double ccw(const Point& point) const { return point.ccw(*this); } | ||||
|     // Clip a line with a bounding box. Returns false if the line is completely outside of the bounding box.
 | ||||
| 	bool   clip_with_bbox(const BoundingBox &bbox); | ||||
| 
 | ||||
|     static double distance_to_squared(const Point &point, const Point &a, const Point &b); | ||||
|     static double distance_to(const Point &point, const Point &a, const Point &b) { return sqrt(distance_to_squared(point, a, b)); } | ||||
|  |  | |||
|  | @ -41,6 +41,9 @@ Model& Model::assign_copy(const Model &rhs) | |||
|         mo->set_model(this); | ||||
| 		this->objects.emplace_back(mo); | ||||
|     } | ||||
| 
 | ||||
|     // copy custom code per height
 | ||||
|     this->custom_gcode_per_height = rhs.custom_gcode_per_height; | ||||
|     return *this; | ||||
| } | ||||
| 
 | ||||
|  | @ -59,6 +62,9 @@ Model& Model::assign_copy(Model &&rhs) | |||
|     for (ModelObject *model_object : this->objects) | ||||
|         model_object->set_model(this); | ||||
|     rhs.objects.clear(); | ||||
| 
 | ||||
|     // copy custom code per height
 | ||||
|     this->custom_gcode_per_height = rhs.custom_gcode_per_height; | ||||
|     return *this; | ||||
| } | ||||
| 
 | ||||
|  | @ -586,6 +592,22 @@ std::string Model::propose_export_file_name_and_path(const std::string &new_exte | |||
|     return boost::filesystem::path(this->propose_export_file_name_and_path()).replace_extension(new_extension).string(); | ||||
| } | ||||
| 
 | ||||
| std::vector<std::pair<double, DynamicPrintConfig>> Model::get_custom_tool_changes(double default_layer_height, size_t num_extruders) const | ||||
| { | ||||
|     std::vector<std::pair<double, DynamicPrintConfig>> custom_tool_changes; | ||||
|     if (!custom_gcode_per_height.empty()) { | ||||
|         for (const CustomGCode& custom_gcode : custom_gcode_per_height) | ||||
|             if (custom_gcode.gcode == ExtruderChangeCode) { | ||||
|                 DynamicPrintConfig config; | ||||
|                 // If extruder count in PrinterSettings was changed, use default (0) extruder for extruders, more than num_extruders
 | ||||
|                 config.set_key_value("extruder", new ConfigOptionInt(custom_gcode.extruder > num_extruders ? 0 : custom_gcode.extruder)); | ||||
|                 // For correct extruders(tools) changing, we should decrease custom_gcode.height value by one default layer height
 | ||||
|                 custom_tool_changes.push_back({ custom_gcode.height - default_layer_height, config }); | ||||
|             } | ||||
|     } | ||||
|     return custom_tool_changes; | ||||
| } | ||||
| 
 | ||||
| ModelObject::~ModelObject() | ||||
| { | ||||
|     this->clear_volumes(); | ||||
|  |  | |||
|  | @ -749,6 +749,37 @@ public: | |||
|     ModelObjectPtrs     objects; | ||||
|     // Wipe tower object.
 | ||||
|     ModelWipeTower	    wipe_tower; | ||||
| 
 | ||||
|     // Extensions for color print
 | ||||
|     struct CustomGCode | ||||
|     { | ||||
|         CustomGCode(double height, const std::string& code, int extruder, const std::string& color) : | ||||
|             height(height), gcode(code), extruder(extruder), color(color) {} | ||||
| 
 | ||||
|         bool operator<(const CustomGCode& other) const { return other.height > this->height; } | ||||
|         bool operator==(const CustomGCode& other) const | ||||
|         { | ||||
|             return (other.height    == this->height)     &&  | ||||
|                    (other.gcode     == this->gcode)      &&  | ||||
|                    (other.extruder  == this->extruder   )&&  | ||||
|                    (other.color     == this->color   ); | ||||
|         } | ||||
|         bool operator!=(const CustomGCode& other) const | ||||
|         { | ||||
|             return (other.height    != this->height)     ||  | ||||
|                    (other.gcode     != this->gcode)      ||  | ||||
|                    (other.extruder  != this->extruder   )||  | ||||
|                    (other.color     != this->color   ); | ||||
|         } | ||||
|          | ||||
|         double      height; | ||||
|         std::string gcode; | ||||
|         int         extruder;   // 0    - "gcode" will be applied for whole print
 | ||||
|                                 // else - "gcode" will be applied only for "extruder" print
 | ||||
|         std::string color;      // if gcode is equal to PausePrintCode, 
 | ||||
|                                 // this field is used for save a short message shown on Printer display 
 | ||||
|     }; | ||||
|     std::vector<CustomGCode> custom_gcode_per_height; | ||||
|      | ||||
|     // Default constructor assigns a new ID to the model.
 | ||||
|     Model() { assert(this->id().valid()); } | ||||
|  | @ -814,6 +845,9 @@ public: | |||
|     // Propose an output path, replace extension. The new_extension shall contain the initial dot.
 | ||||
|     std::string   propose_export_file_name_and_path(const std::string &new_extension) const; | ||||
| 
 | ||||
|     // from custom_gcode_per_height get just tool_change codes
 | ||||
|     std::vector<std::pair<double, DynamicPrintConfig>> get_custom_tool_changes(double default_layer_height, size_t num_extruders) const; | ||||
| 
 | ||||
| private: | ||||
| 	explicit Model(int) : ObjectBase(-1) { assert(this->id().invalid()); }; | ||||
| 	void assign_new_unique_ids_recursive(); | ||||
|  |  | |||
|  | @ -319,7 +319,7 @@ Polyline MotionPlannerGraph::shortest_path(size_t node_start, size_t node_end) c | |||
|     std::vector<size_t>   map_node_to_queue_id(m_adjacency_list.size(), size_t(-1)); | ||||
|     distance[node_start] = 0.; | ||||
| 
 | ||||
|     auto queue = make_mutable_priority_queue<node_t>( | ||||
|     auto queue = make_mutable_priority_queue<node_t, false>( | ||||
|         [&map_node_to_queue_id](const node_t node, size_t idx) { map_node_to_queue_id[node] = idx; }, | ||||
|         [&distance](const node_t node1, const node_t node2) { return distance[node1] < distance[node2]; }); | ||||
|     queue.reserve(m_adjacency_list.size()); | ||||
|  |  | |||
|  | @ -3,7 +3,7 @@ | |||
| 
 | ||||
| #include <assert.h> | ||||
| 
 | ||||
| template<typename T, typename IndexSetter, typename LessPredicate> | ||||
| template<typename T, typename IndexSetter, typename LessPredicate, const bool ResetIndexWhenRemoved = false> | ||||
| class MutablePriorityQueue | ||||
| { | ||||
| public: | ||||
|  | @ -42,26 +42,30 @@ private: | |||
| 	LessPredicate	m_less_predicate; | ||||
| }; | ||||
| 
 | ||||
| template<typename T, typename IndexSetter, typename LessPredicate> | ||||
| MutablePriorityQueue<T, IndexSetter, LessPredicate> make_mutable_priority_queue(IndexSetter &&index_setter, LessPredicate &&less_predicate) | ||||
| template<typename T, const bool ResetIndexWhenRemoved, typename IndexSetter, typename LessPredicate> | ||||
| MutablePriorityQueue<T, IndexSetter, LessPredicate, ResetIndexWhenRemoved> make_mutable_priority_queue(IndexSetter &&index_setter, LessPredicate &&less_predicate) | ||||
| { | ||||
|     return MutablePriorityQueue<T, IndexSetter, LessPredicate>( | ||||
|     return MutablePriorityQueue<T, IndexSetter, LessPredicate, ResetIndexWhenRemoved>( | ||||
|     	std::forward<IndexSetter>(index_setter), std::forward<LessPredicate>(less_predicate)); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::clear() | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::clear() | ||||
| {  | ||||
| #ifndef NDEBUG | ||||
| 	for (size_t idx = 0; idx < m_heap.size(); ++ idx) | ||||
| 		// Mark as removed from the queue.
 | ||||
| 		m_index_setter(m_heap[idx], std::numeric_limits<size_t>::max()); | ||||
| #ifdef NDEBUG | ||||
| 	// Only mark as removed from the queue in release mode, if configured so.
 | ||||
| 	if (ResetIndexWhenRemoved) | ||||
| #endif /* NDEBUG */ | ||||
| 	{ | ||||
| 		for (size_t idx = 0; idx < m_heap.size(); ++ idx) | ||||
| 			// Mark as removed from the queue.
 | ||||
| 			m_index_setter(m_heap[idx], std::numeric_limits<size_t>::max()); | ||||
| 	} | ||||
| 	m_heap.clear(); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::push(const T &item) | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::push(const T &item) | ||||
| { | ||||
| 	size_t idx = m_heap.size(); | ||||
| 	m_heap.emplace_back(item); | ||||
|  | @ -69,8 +73,8 @@ inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::push(const T &i | |||
| 	update_heap_up(0, idx); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::push(T &&item) | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::push(T &&item) | ||||
| { | ||||
| 	size_t idx = m_heap.size(); | ||||
| 	m_heap.emplace_back(std::move(item)); | ||||
|  | @ -78,14 +82,18 @@ inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::push(T &&item) | |||
| 	update_heap_up(0, idx); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::pop() | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::pop() | ||||
| { | ||||
| 	assert(! m_heap.empty()); | ||||
| #ifndef NDEBUG | ||||
| 	// Mark as removed from the queue.
 | ||||
| 	m_index_setter(m_heap.front(), std::numeric_limits<size_t>::max()); | ||||
| #ifdef NDEBUG | ||||
| 	// Only mark as removed from the queue in release mode, if configured so.
 | ||||
| 	if (ResetIndexWhenRemoved) | ||||
| #endif /* NDEBUG */ | ||||
| 	{ | ||||
| 		// Mark as removed from the queue.
 | ||||
| 		m_index_setter(m_heap.front(), std::numeric_limits<size_t>::max()); | ||||
| 	} | ||||
| 	if (m_heap.size() > 1) { | ||||
| 		m_heap.front() = m_heap.back(); | ||||
| 		m_heap.pop_back(); | ||||
|  | @ -95,14 +103,18 @@ inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::pop() | |||
| 		m_heap.clear(); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::remove(size_t idx) | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::remove(size_t idx) | ||||
| { | ||||
| 	assert(idx < m_heap.size()); | ||||
| #ifndef NDEBUG | ||||
| 	// Mark as removed from the queue.
 | ||||
| 	m_index_setter(m_heap[idx], std::numeric_limits<size_t>::max()); | ||||
| #ifdef NDEBUG | ||||
| 	// Only mark as removed from the queue in release mode, if configured so.
 | ||||
| 	if (ResetIndexWhenRemoved) | ||||
| #endif /* NDEBUG */ | ||||
| 	{ | ||||
| 		// Mark as removed from the queue.
 | ||||
| 		m_index_setter(m_heap[idx], std::numeric_limits<size_t>::max()); | ||||
| 	} | ||||
| 	if (idx + 1 == m_heap.size()) { | ||||
| 		m_heap.pop_back(); | ||||
| 		return; | ||||
|  | @ -114,8 +126,8 @@ inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::remove(size_t i | |||
| 	update_heap_up(0, idx); | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::update_heap_up(size_t top, size_t bottom) | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::update_heap_up(size_t top, size_t bottom) | ||||
| { | ||||
| 	size_t childIdx = bottom; | ||||
| 	T *child = &m_heap[childIdx]; | ||||
|  | @ -138,8 +150,8 @@ inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::update_heap_up( | |||
| 	} | ||||
| } | ||||
| 
 | ||||
| template<class T, class LessPredicate, class IndexSetter> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter>::update_heap_down(size_t top, size_t bottom) | ||||
| template<class T, class LessPredicate, class IndexSetter, const bool ResetIndexWhenRemoved> | ||||
| inline void MutablePriorityQueue<T, LessPredicate, IndexSetter, ResetIndexWhenRemoved>::update_heap_down(size_t top, size_t bottom) | ||||
| { | ||||
| 	size_t parentIdx = top; | ||||
| 	T *parent = &m_heap[parentIdx]; | ||||
|  |  | |||
|  | @ -637,11 +637,59 @@ Print::ApplyStatus Print::apply(const Model &model, DynamicPrintConfig new_full_ | |||
|             else | ||||
|                 m_ranges.emplace_back(t_layer_height_range(m_ranges.back().first.second, DBL_MAX), nullptr); | ||||
|         } | ||||
| 
 | ||||
|         // Convert input config ranges into continuous non-overlapping sorted vector of intervals and their configs,
 | ||||
|         // considering custom_tool_change values
 | ||||
|         void assign(const t_layer_config_ranges &in, const std::vector<std::pair<double, DynamicPrintConfig>> &custom_tool_changes) { | ||||
|             m_ranges.clear(); | ||||
|             m_ranges.reserve(in.size()); | ||||
|             // Input ranges are sorted lexicographically. First range trims the other ranges.
 | ||||
|             coordf_t last_z = 0; | ||||
|             for (const std::pair<const t_layer_height_range, DynamicPrintConfig> &range : in) | ||||
| 				if (range.first.second > last_z) { | ||||
|                     coordf_t min_z = std::max(range.first.first, 0.); | ||||
|                     if (min_z > last_z + EPSILON) { | ||||
|                         m_ranges.emplace_back(t_layer_height_range(last_z, min_z), nullptr); | ||||
|                         last_z = min_z; | ||||
|                     } | ||||
|                     if (range.first.second > last_z + EPSILON) { | ||||
| 						const DynamicPrintConfig* cfg = &range.second; | ||||
|                         m_ranges.emplace_back(t_layer_height_range(last_z, range.first.second), cfg); | ||||
|                         last_z = range.first.second; | ||||
|                     } | ||||
|                 } | ||||
| 
 | ||||
|             // add ranges for extruder changes from custom_tool_changes
 | ||||
|             for (size_t i = 0; i < custom_tool_changes.size(); i++) { | ||||
|                 const DynamicPrintConfig* cfg = &custom_tool_changes[i].second; | ||||
|                 coordf_t cur_Z = custom_tool_changes[i].first; | ||||
|                 coordf_t next_Z = i == custom_tool_changes.size()-1 ? DBL_MAX : custom_tool_changes[i+1].first; | ||||
|                 if (cur_Z > last_z + EPSILON) { | ||||
|                     if (i==0) | ||||
|                         m_ranges.emplace_back(t_layer_height_range(last_z, cur_Z), nullptr); | ||||
|                     m_ranges.emplace_back(t_layer_height_range(cur_Z, next_Z), cfg); | ||||
|                 } | ||||
|                 else if (next_Z > last_z + EPSILON) | ||||
|                     m_ranges.emplace_back(t_layer_height_range(last_z, next_Z), cfg); | ||||
|             } | ||||
| 
 | ||||
|             if (m_ranges.empty()) | ||||
|                 m_ranges.emplace_back(t_layer_height_range(0, DBL_MAX), nullptr); | ||||
|             else if (m_ranges.back().second == nullptr) | ||||
|                 m_ranges.back().first.second = DBL_MAX; | ||||
|             else if (m_ranges.back().first.second != DBL_MAX) | ||||
|                 m_ranges.emplace_back(t_layer_height_range(m_ranges.back().first.second, DBL_MAX), nullptr); | ||||
|         } | ||||
|         const DynamicPrintConfig* config(const t_layer_height_range &range) const { | ||||
|             auto it = std::lower_bound(m_ranges.begin(), m_ranges.end(), std::make_pair< t_layer_height_range, const DynamicPrintConfig*>(t_layer_height_range(range.first - EPSILON, range.second - EPSILON), nullptr)); | ||||
|             assert(it != m_ranges.end()); | ||||
|             assert(it == m_ranges.end() || std::abs(it->first.first  - range.first ) < EPSILON); | ||||
|             assert(it == m_ranges.end() || std::abs(it->first.second - range.second) < EPSILON); | ||||
|             // #ys_FIXME_COLOR
 | ||||
|             // assert(it != m_ranges.end());
 | ||||
|             // assert(it == m_ranges.end() || std::abs(it->first.first  - range.first ) < EPSILON);
 | ||||
|             // assert(it == m_ranges.end() || std::abs(it->first.second - range.second) < EPSILON);
 | ||||
|             if (it == m_ranges.end() || | ||||
|                 std::abs(it->first.first - range.first) > EPSILON || | ||||
|                 std::abs(it->first.second - range.second) > EPSILON ) | ||||
|                 return nullptr; // desired range doesn't found
 | ||||
|             return (it == m_ranges.end()) ? nullptr : it->second; | ||||
|         } | ||||
|         std::vector<std::pair<t_layer_height_range, const DynamicPrintConfig*>>::const_iterator begin() const { return m_ranges.cbegin(); } | ||||
|  | @ -689,6 +737,13 @@ Print::ApplyStatus Print::apply(const Model &model, DynamicPrintConfig new_full_ | |||
|             // The object list did not change.
 | ||||
| 			for (const ModelObject *model_object : m_model.objects) | ||||
| 				model_object_status.emplace(model_object->id(), ModelObjectStatus::Old); | ||||
| 
 | ||||
|             // But if custom gcode per layer height was changed
 | ||||
|             if (m_model.custom_gcode_per_height != model.custom_gcode_per_height) { | ||||
|                 // we should stop background processing
 | ||||
|                 update_apply_status(this->invalidate_step(psGCodeExport)); | ||||
|                 m_model.custom_gcode_per_height = model.custom_gcode_per_height; | ||||
|             } | ||||
|         } else if (model_object_list_extended(m_model, model)) { | ||||
|             // Add new objects. Their volumes and configs will be synchronized later.
 | ||||
|             update_apply_status(this->invalidate_step(psGCodeExport)); | ||||
|  | @ -780,6 +835,9 @@ Print::ApplyStatus Print::apply(const Model &model, DynamicPrintConfig new_full_ | |||
|     for (PrintObject *print_object : m_objects) | ||||
|         print_object_status.emplace(PrintObjectStatus(print_object)); | ||||
| 
 | ||||
|     std::vector<std::pair<double, DynamicPrintConfig>> custom_tool_changes =  | ||||
|         m_model.get_custom_tool_changes(m_default_object_config.layer_height, num_extruders); | ||||
| 
 | ||||
|     // 3) Synchronize ModelObjects & PrintObjects.
 | ||||
|     for (size_t idx_model_object = 0; idx_model_object < model.objects.size(); ++ idx_model_object) { | ||||
|         ModelObject &model_object = *m_model.objects[idx_model_object]; | ||||
|  | @ -787,7 +845,9 @@ Print::ApplyStatus Print::apply(const Model &model, DynamicPrintConfig new_full_ | |||
|         assert(it_status != model_object_status.end()); | ||||
|         assert(it_status->status != ModelObjectStatus::Deleted); | ||||
| 		const ModelObject& model_object_new = *model.objects[idx_model_object]; | ||||
| 		const_cast<ModelObjectStatus&>(*it_status).layer_ranges.assign(model_object_new.layer_config_ranges); | ||||
|         // ys_FIXME_COLOR
 | ||||
| 		// const_cast<ModelObjectStatus&>(*it_status).layer_ranges.assign(model_object_new.layer_config_ranges);
 | ||||
|         const_cast<ModelObjectStatus&>(*it_status).layer_ranges.assign(model_object_new.layer_config_ranges, custom_tool_changes); | ||||
|         if (it_status->status == ModelObjectStatus::New) | ||||
|             // PrintObject instances will be added in the next loop.
 | ||||
|             continue; | ||||
|  | @ -955,6 +1015,8 @@ Print::ApplyStatus Print::apply(const Model &model, DynamicPrintConfig new_full_ | |||
|         PrintRegionConfig  this_region_config; | ||||
|         bool               this_region_config_set = false; | ||||
|         for (PrintObject *print_object : m_objects) { | ||||
|             if(m_force_update_print_regions && !custom_tool_changes.empty()) | ||||
|                 goto print_object_end; | ||||
|             const LayerRanges *layer_ranges; | ||||
|             { | ||||
|                 auto it_status = model_object_status.find(ModelObjectStatus(print_object->model_object()->id())); | ||||
|  | @ -1190,6 +1252,8 @@ std::string Print::validate() const | |||
|             return L("Ooze prevention is currently not supported with the wipe tower enabled."); | ||||
|         if (m_config.use_volumetric_e) | ||||
|             return L("The Wipe Tower currently does not support volumetric E (use_volumetric_e=0)."); | ||||
|         if (m_config.complete_objects && extruders().size() > 1) | ||||
|             return L("The Wipe Tower is currently not supported for multimaterial sequential prints."); | ||||
|          | ||||
|         if (m_objects.size() > 1) { | ||||
|             bool                                has_custom_layering = false; | ||||
|  | @ -1258,7 +1322,7 @@ std::string Print::validate() const | |||
|                             } while (ref_z == next_ref_z); | ||||
|                         } | ||||
|                         if (std::abs(this_height - ref_height) > EPSILON) | ||||
|                             return L("The Wipe tower is only supported if all objects have the same layer height profile"); | ||||
|                             return L("The Wipe tower is only supported if all objects have the same variable layer height"); | ||||
|                         i += 2; | ||||
|                     } | ||||
|                 } | ||||
|  | @ -1538,7 +1602,7 @@ void Print::process() | |||
| // write error into the G-code, cannot execute post-processing scripts).
 | ||||
| // It is up to the caller to show an error message.
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| std::string Print::export_gcode(const std::string& path_template, GCodePreviewData* preview_data, const std::vector<ThumbnailData>* thumbnail_data) | ||||
| std::string Print::export_gcode(const std::string& path_template, GCodePreviewData* preview_data, ThumbnailsGeneratorCallback thumbnail_cb) | ||||
| #else | ||||
| std::string Print::export_gcode(const std::string &path_template, GCodePreviewData *preview_data) | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -1559,7 +1623,7 @@ std::string Print::export_gcode(const std::string &path_template, GCodePreviewDa | |||
|     // The following line may die for multiple reasons.
 | ||||
|     GCode gcode; | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|     gcode.do_export(this, path.c_str(), preview_data, thumbnail_data); | ||||
|     gcode.do_export(this, path.c_str(), preview_data, thumbnail_cb); | ||||
| #else | ||||
|     gcode.do_export(this, path.c_str(), preview_data); | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -1618,11 +1682,18 @@ void Print::_make_skirt() | |||
|     if (has_wipe_tower() && ! m_wipe_tower_data.tool_changes.empty()) { | ||||
|         double width = m_config.wipe_tower_width + 2*m_wipe_tower_data.brim_width; | ||||
|         double depth = m_wipe_tower_data.depth + 2*m_wipe_tower_data.brim_width; | ||||
|         Vec2d pt = Vec2d(m_config.wipe_tower_x-m_wipe_tower_data.brim_width, m_config.wipe_tower_y-m_wipe_tower_data.brim_width); | ||||
|         points.push_back(Point(scale_(pt.x()), scale_(pt.y()))); | ||||
|         points.push_back(Point(scale_(pt.x()+width), scale_(pt.y()))); | ||||
|         points.push_back(Point(scale_(pt.x()+width), scale_(pt.y()+depth))); | ||||
|         points.push_back(Point(scale_(pt.x()), scale_(pt.y()+depth))); | ||||
|         Vec2d pt = Vec2d(-m_wipe_tower_data.brim_width, -m_wipe_tower_data.brim_width); | ||||
| 
 | ||||
|         std::vector<Vec2d> pts; | ||||
|         pts.push_back(Vec2d(pt.x(), pt.y())); | ||||
|         pts.push_back(Vec2d(pt.x()+width, pt.y())); | ||||
|         pts.push_back(Vec2d(pt.x()+width, pt.y()+depth)); | ||||
|         pts.push_back(Vec2d(pt.x(), pt.y()+depth)); | ||||
|         for (Vec2d& pt : pts) { | ||||
|             pt = Eigen::Rotation2Dd(Geometry::deg2rad(m_config.wipe_tower_rotation_angle.value)) * pt; | ||||
|             pt += Vec2d(m_config.wipe_tower_x.value, m_config.wipe_tower_y.value); | ||||
|             points.push_back(Point(scale_(pt.x()), scale_(pt.y()))); | ||||
|         } | ||||
|     } | ||||
| 
 | ||||
|     if (points.size() < 3) | ||||
|  |  | |||
|  | @ -11,6 +11,9 @@ | |||
| #include "Slicing.hpp" | ||||
| #include "GCode/ToolOrdering.hpp" | ||||
| #include "GCode/WipeTower.hpp" | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| #include "GCode/ThumbnailData.hpp" | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| 
 | ||||
| namespace Slic3r { | ||||
| 
 | ||||
|  | @ -19,9 +22,6 @@ class PrintObject; | |||
| class ModelObject; | ||||
| class GCode; | ||||
| class GCodePreviewData; | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
| struct ThumbnailData; | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
| 
 | ||||
| // Print step IDs for keeping track of the print state.
 | ||||
| enum PrintStep { | ||||
|  | @ -311,7 +311,7 @@ public: | |||
|     // Exports G-code into a file name based on the path_template, returns the file path of the generated G-code file.
 | ||||
|     // If preview_data is not null, the preview_data is filled in for the G-code visualization (not used by the command line Slic3r).
 | ||||
| #if ENABLE_THUMBNAIL_GENERATOR | ||||
|     std::string         export_gcode(const std::string& path_template, GCodePreviewData* preview_data, const std::vector<ThumbnailData>* thumbnail_data = nullptr); | ||||
|     std::string         export_gcode(const std::string& path_template, GCodePreviewData* preview_data, ThumbnailsGeneratorCallback thumbnail_cb = nullptr); | ||||
| #else | ||||
|     std::string         export_gcode(const std::string &path_template, GCodePreviewData *preview_data); | ||||
| #endif // ENABLE_THUMBNAIL_GENERATOR
 | ||||
|  | @ -370,6 +370,9 @@ public: | |||
|     // Accessed by SupportMaterial
 | ||||
|     const PrintRegion*  get_region(size_t idx) const  { return m_regions[idx]; } | ||||
| 
 | ||||
|     // force update of PrintRegions, when custom_tool_change is not empty and (Re)Slicing is started
 | ||||
|     void set_force_update_print_regions(bool force_update_print_regions) { m_force_update_print_regions = force_update_print_regions; } | ||||
| 
 | ||||
| protected: | ||||
|     // methods for handling regions
 | ||||
|     PrintRegion*        get_region(size_t idx)        { return m_regions[idx]; } | ||||
|  | @ -412,6 +415,9 @@ private: | |||
|     // Estimated print time, filament consumed.
 | ||||
|     PrintStatistics                         m_print_statistics; | ||||
| 
 | ||||
|     // flag used
 | ||||
|     bool                                    m_force_update_print_regions = false; | ||||
| 
 | ||||
|     // To allow GCode to set the Print's GCodeExport step status.
 | ||||
|     friend class GCode; | ||||
|     // Allow PrintObject to access m_mutex and m_cancel_callback.
 | ||||
|  |  | |||
|  | @ -71,6 +71,12 @@ enum SLAPillarConnectionMode { | |||
|     slapcmDynamic | ||||
| }; | ||||
| 
 | ||||
| // ys_FIXME ! may be, it's not a best place
 | ||||
| // Additional Codes which can be set by user using DoubleSlider
 | ||||
| static const std::string ColorChangeCode    = "M600"; | ||||
| static const std::string PausePrintCode     = "M601"; | ||||
| static const std::string ExtruderChangeCode = "tool_change"; | ||||
| 
 | ||||
| template<> inline const t_config_enum_values& ConfigOptionEnum<PrinterTechnology>::get_enum_values() { | ||||
|     static t_config_enum_values keys_map; | ||||
|     if (keys_map.empty()) { | ||||
|  |  | |||
|  | @ -1522,9 +1522,9 @@ bool PrintObject::update_layer_height_profile(const ModelObject &model_object, c | |||
|         layer_height_profile.clear(); | ||||
| 
 | ||||
|     if (layer_height_profile.empty()) { | ||||
|             //layer_height_profile = layer_height_profile_adaptive(slicing_parameters, model_object.layer_config_ranges, model_object.volumes);
 | ||||
|             layer_height_profile = layer_height_profile_from_ranges(slicing_parameters, model_object.layer_config_ranges); | ||||
|        	updated = true; | ||||
|         //layer_height_profile = layer_height_profile_adaptive(slicing_parameters, model_object.layer_config_ranges, model_object.volumes);
 | ||||
|         layer_height_profile = layer_height_profile_from_ranges(slicing_parameters, model_object.layer_config_ranges); | ||||
|         updated = true; | ||||
|     } | ||||
|     return updated; | ||||
| } | ||||
|  |  | |||
|  | @ -114,6 +114,7 @@ public: | |||
| 	bool operator&(const Semver &b) const { return ::semver_satisfies_patch(ver, b.ver) != 0; } | ||||
| 	bool operator^(const Semver &b) const { return ::semver_satisfies_caret(ver, b.ver) != 0; } | ||||
| 	bool in_range(const Semver &low, const Semver &high) const { return low <= *this && *this <= high; } | ||||
| 	bool valid()                    const { return *this != zero() && *this != inf() && *this != invalid(); } | ||||
| 
 | ||||
| 	// Conversion
 | ||||
| 	std::string to_string() const { | ||||
|  |  | |||
										
											
												File diff suppressed because it is too large
												Load diff
											
										
									
								
							|  | @ -224,40 +224,59 @@ std::vector<coordf_t> layer_height_profile_from_ranges( | |||
| 
 | ||||
| // Based on the work of @platsch
 | ||||
| // Fill layer_height_profile by heights ensuring a prescribed maximum cusp height.
 | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| std::vector<double> layer_height_profile_adaptive(const SlicingParameters& slicing_params, | ||||
|     const ModelObject& object, float cusp_value) | ||||
| #else | ||||
| std::vector<coordf_t> layer_height_profile_adaptive( | ||||
|     const SlicingParameters     &slicing_params, | ||||
|     const t_layer_config_ranges & /* layer_config_ranges */, | ||||
|     const ModelVolumePtrs		&volumes) | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| { | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     // 1) Initialize the SlicingAdaptive class with the object meshes.
 | ||||
|     SlicingAdaptive as; | ||||
|     as.set_slicing_parameters(slicing_params); | ||||
|     for (const ModelVolume *volume : volumes) | ||||
|     as.set_object(object); | ||||
| #else | ||||
|     // 1) Initialize the SlicingAdaptive class with the object meshes.
 | ||||
|     SlicingAdaptive as; | ||||
|     as.set_slicing_parameters(slicing_params); | ||||
|     for (const ModelVolume* volume : volumes) | ||||
|         if (volume->is_model_part()) | ||||
|             as.add_mesh(&volume->mesh()); | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
|     as.prepare(); | ||||
| 
 | ||||
|     // 2) Generate layers using the algorithm of @platsch 
 | ||||
|     // loop until we have at least one layer and the max slice_z reaches the object height
 | ||||
|     //FIXME make it configurable
 | ||||
|     // Cusp value: A maximum allowed distance from a corner of a rectangular extrusion to a chrodal line, in mm.
 | ||||
|     const coordf_t cusp_value = 0.2; // $self->config->get_value('cusp_value');
 | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     double cusp_value = 0.2; | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
|     std::vector<coordf_t> layer_height_profile; | ||||
|     layer_height_profile.push_back(0.); | ||||
|     std::vector<double> layer_height_profile; | ||||
|     layer_height_profile.push_back(0.0); | ||||
|     layer_height_profile.push_back(slicing_params.first_object_layer_height); | ||||
|     if (slicing_params.first_object_layer_height_fixed()) { | ||||
|         layer_height_profile.push_back(slicing_params.first_object_layer_height); | ||||
|         layer_height_profile.push_back(slicing_params.first_object_layer_height); | ||||
|     } | ||||
|     coordf_t slice_z = slicing_params.first_object_layer_height; | ||||
|     coordf_t height  = slicing_params.first_object_layer_height; | ||||
|     double slice_z = slicing_params.first_object_layer_height; | ||||
|     int current_facet = 0; | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     while (slice_z <= slicing_params.object_print_z_height()) { | ||||
|         double height = slicing_params.max_layer_height; | ||||
| #else | ||||
|     double height = slicing_params.first_object_layer_height; | ||||
|     while ((slice_z - height) <= slicing_params.object_print_z_height()) { | ||||
|         height = 999; | ||||
|         height = 999.0; | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|         // Slic3r::debugf "\n Slice layer: %d\n", $id;
 | ||||
|         // determine next layer height
 | ||||
|         coordf_t cusp_height = as.cusp_height(slice_z, cusp_value, current_facet); | ||||
|         double cusp_height = as.cusp_height((float)slice_z, cusp_value, current_facet); | ||||
| 
 | ||||
|         // check for horizontal features and object size
 | ||||
|         /*
 | ||||
|         if($self->config->get_value('match_horizontal_surfaces')) { | ||||
|  | @ -303,19 +322,113 @@ std::vector<coordf_t> layer_height_profile_adaptive( | |||
|         layer_height_profile.push_back(slice_z); | ||||
|         layer_height_profile.push_back(height); | ||||
|         slice_z += height; | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|         layer_height_profile.push_back(slice_z); | ||||
|         layer_height_profile.push_back(height); | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|     } | ||||
| 
 | ||||
|     coordf_t last = std::max(slicing_params.first_object_layer_height, layer_height_profile[layer_height_profile.size() - 2]); | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     double z_gap = slicing_params.object_print_z_height() - layer_height_profile[layer_height_profile.size() - 2]; | ||||
|     if (z_gap > 0.0) | ||||
|     { | ||||
|         layer_height_profile.push_back(slicing_params.object_print_z_height()); | ||||
|         layer_height_profile.push_back(clamp(slicing_params.min_layer_height, slicing_params.max_layer_height, z_gap)); | ||||
|     } | ||||
| #else | ||||
|     double last = std::max(slicing_params.first_object_layer_height, layer_height_profile[layer_height_profile.size() - 2]); | ||||
|     layer_height_profile.push_back(last); | ||||
|     layer_height_profile.push_back(slicing_params.first_object_layer_height); | ||||
|     layer_height_profile.push_back(slicing_params.object_print_z_height()); | ||||
|     layer_height_profile.push_back(slicing_params.first_object_layer_height); | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
|     return layer_height_profile; | ||||
| } | ||||
| 
 | ||||
| std::vector<double> smooth_height_profile(const std::vector<double>& profile, const SlicingParameters& slicing_params, const HeightProfileSmoothingParams& smoothing_params) | ||||
| { | ||||
|     auto gauss_blur = [&slicing_params](const std::vector<double>& profile, const HeightProfileSmoothingParams& smoothing_params) -> std::vector<double> { | ||||
|         auto gauss_kernel = [] (unsigned int radius) -> std::vector<double> { | ||||
|             unsigned int size = 2 * radius + 1; | ||||
|             std::vector<double> ret; | ||||
|             ret.reserve(size); | ||||
| 
 | ||||
|             // Reworked from static inline int getGaussianKernelSize(float sigma) taken from opencv-4.1.2\modules\features2d\src\kaze\AKAZEFeatures.cpp
 | ||||
|             double sigma = 0.3 * (double)(radius - 1) + 0.8; | ||||
|             double two_sq_sigma = 2.0 * sigma * sigma; | ||||
|             double inv_root_two_pi_sq_sigma = 1.0 / ::sqrt(M_PI * two_sq_sigma); | ||||
| 
 | ||||
|             for (unsigned int i = 0; i < size; ++i) | ||||
|             { | ||||
|                 double x = (double)i - (double)radius; | ||||
|                 ret.push_back(inv_root_two_pi_sq_sigma * ::exp(-x * x / two_sq_sigma)); | ||||
|             } | ||||
| 
 | ||||
|             return ret; | ||||
|         }; | ||||
| 
 | ||||
|         // skip first layer ?
 | ||||
|         size_t skip_count = slicing_params.first_object_layer_height_fixed() ? 4 : 0; | ||||
| 
 | ||||
|         // not enough data to smmoth
 | ||||
|         if ((int)profile.size() - (int)skip_count < 6) | ||||
|             return profile; | ||||
|          | ||||
|         unsigned int radius = std::max(smoothing_params.radius, (unsigned int)1); | ||||
|         std::vector<double> kernel = gauss_kernel(radius); | ||||
|         int two_radius = 2 * (int)radius; | ||||
| 
 | ||||
|         std::vector<double> ret; | ||||
|         size_t size = profile.size(); | ||||
|         ret.reserve(size); | ||||
| 
 | ||||
|         // leave first layer untouched
 | ||||
|         for (size_t i = 0; i < skip_count; ++i) | ||||
|         { | ||||
|             ret.push_back(profile[i]); | ||||
|         } | ||||
| 
 | ||||
|         // smooth the rest of the profile by biasing a gaussian blur
 | ||||
|         // the bias moves the smoothed profile closer to the min_layer_height
 | ||||
|         double delta_h = slicing_params.max_layer_height - slicing_params.min_layer_height; | ||||
|         double inv_delta_h = (delta_h != 0.0) ? 1.0 / delta_h : 1.0; | ||||
| 
 | ||||
|         double max_dz_band = (double)radius * slicing_params.layer_height; | ||||
|         for (size_t i = skip_count; i < size; i += 2) | ||||
|         { | ||||
|             double zi = profile[i]; | ||||
|             double hi = profile[i + 1]; | ||||
|             ret.push_back(zi); | ||||
|             ret.push_back(0.0); | ||||
|             double& height = ret.back(); | ||||
|             int begin = std::max((int)i - two_radius, (int)skip_count); | ||||
|             int end = std::min((int)i + two_radius, (int)size - 2); | ||||
|             double weight_total = 0.0; | ||||
|             for (int j = begin; j <= end; j += 2) | ||||
|             { | ||||
|                 int kernel_id = radius + (j - (int)i) / 2; | ||||
|                 double dz = std::abs(zi - profile[j]); | ||||
|                 if (dz * slicing_params.layer_height <= max_dz_band) | ||||
|                 { | ||||
|                     double dh = std::abs(slicing_params.max_layer_height - profile[j + 1]); | ||||
|                     double weight = kernel[kernel_id] * sqrt(dh * inv_delta_h); | ||||
|                     height += weight * profile[j + 1]; | ||||
|                     weight_total += weight; | ||||
|                 } | ||||
|             } | ||||
| 
 | ||||
|             height = clamp(slicing_params.min_layer_height, slicing_params.max_layer_height, (weight_total != 0.0) ? height /= weight_total : hi); | ||||
|             if (smoothing_params.keep_min) | ||||
|                 height = std::min(height, hi); | ||||
|         } | ||||
| 
 | ||||
|         return ret; | ||||
|     }; | ||||
| 
 | ||||
|     return gauss_blur(profile, smoothing_params); | ||||
| } | ||||
| 
 | ||||
| void adjust_layer_height_profile( | ||||
|     const SlicingParameters     &slicing_params, | ||||
|     std::vector<coordf_t> 		&layer_height_profile, | ||||
|  | @ -609,7 +722,11 @@ int generate_layer_height_texture( | |||
|             const Vec3crd &color1 = palette_raw[idx1]; | ||||
|             const Vec3crd &color2 = palette_raw[idx2]; | ||||
|             coordf_t z = cell_to_z * coordf_t(cell); | ||||
| 			assert(z >= lo && z <= hi); | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|             assert((lo - EPSILON <= z) && (z <= hi + EPSILON)); | ||||
| #else | ||||
|             assert(z >= lo && z <= hi); | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|             // Intensity profile to visualize the layers.
 | ||||
|             coordf_t intensity = cos(M_PI * 0.7 * (mid - z) / h); | ||||
|             // Color mapping from layer height to RGB.
 | ||||
|  |  | |||
|  | @ -18,8 +18,12 @@ namespace Slic3r | |||
| 
 | ||||
| class PrintConfig; | ||||
| class PrintObjectConfig; | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| class ModelObject; | ||||
| #else | ||||
| class ModelVolume; | ||||
| typedef std::vector<ModelVolume*> ModelVolumePtrs; | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| // Parameters to guide object slicing and support generation.
 | ||||
| // The slicing parameters account for a raft and whether the 1st object layer is printed with a normal or a bridging flow
 | ||||
|  | @ -138,11 +142,29 @@ extern std::vector<coordf_t> layer_height_profile_from_ranges( | |||
|     const SlicingParameters     &slicing_params, | ||||
|     const t_layer_config_ranges &layer_config_ranges); | ||||
| 
 | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| extern std::vector<double> layer_height_profile_adaptive( | ||||
|     const SlicingParameters& slicing_params, | ||||
|     const ModelObject& object, float cusp_value); | ||||
| 
 | ||||
| struct HeightProfileSmoothingParams | ||||
| { | ||||
|     unsigned int radius; | ||||
|     bool keep_min; | ||||
| 
 | ||||
|     HeightProfileSmoothingParams() : radius(5), keep_min(false) {} | ||||
|     HeightProfileSmoothingParams(unsigned int radius, bool keep_min) : radius(radius), keep_min(keep_min) {} | ||||
| }; | ||||
| 
 | ||||
| extern std::vector<double> smooth_height_profile( | ||||
|     const std::vector<double>& profile, const SlicingParameters& slicing_params, | ||||
|     const HeightProfileSmoothingParams& smoothing_params); | ||||
| #else | ||||
| extern std::vector<coordf_t> layer_height_profile_adaptive( | ||||
|     const SlicingParameters     &slicing_params, | ||||
|     const t_layer_config_ranges &layer_config_ranges, | ||||
|     const ModelVolumePtrs       &volumes); | ||||
| 
 | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| enum LayerHeightEditActionType : unsigned int { | ||||
|     LAYER_HEIGHT_EDIT_ACTION_INCREASE = 0, | ||||
|  |  | |||
|  | @ -1,16 +1,22 @@ | |||
| #include "libslic3r.h" | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| #include "Model.hpp" | ||||
| #else | ||||
| #include "TriangleMesh.hpp" | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| #include "SlicingAdaptive.hpp" | ||||
| 
 | ||||
| namespace Slic3r | ||||
| { | ||||
| 
 | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| void SlicingAdaptive::clear() | ||||
| { | ||||
| 	m_meshes.clear(); | ||||
|     m_meshes.clear(); | ||||
| 	m_faces.clear(); | ||||
| 	m_face_normal_z.clear(); | ||||
| } | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| std::pair<float, float> face_z_span(const stl_facet *f) | ||||
| { | ||||
|  | @ -21,38 +27,54 @@ std::pair<float, float> face_z_span(const stl_facet *f) | |||
| 
 | ||||
| void SlicingAdaptive::prepare() | ||||
| { | ||||
| 	// 1) Collect faces of all meshes.
 | ||||
| 	int nfaces_total = 0; | ||||
| 	for (std::vector<const TriangleMesh*>::const_iterator it_mesh = m_meshes.begin(); it_mesh != m_meshes.end(); ++ it_mesh) | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     if (m_object == nullptr) | ||||
|         return; | ||||
| 
 | ||||
|     m_faces.clear(); | ||||
|     m_face_normal_z.clear(); | ||||
| 
 | ||||
|     m_mesh = m_object->raw_mesh(); | ||||
|     const ModelInstance* first_instance = m_object->instances.front(); | ||||
|     m_mesh.transform(first_instance->get_matrix(), first_instance->is_left_handed()); | ||||
| 
 | ||||
|     // 1) Collect faces from mesh.
 | ||||
|     m_faces.reserve(m_mesh.stl.stats.number_of_facets); | ||||
|     for (stl_facet& face : m_mesh.stl.facet_start) | ||||
|     { | ||||
|         face.normal.normalize(); | ||||
|         m_faces.emplace_back(&face); | ||||
|     } | ||||
| #else | ||||
|     // 1) Collect faces of all meshes.
 | ||||
|     int nfaces_total = 0; | ||||
|     for (std::vector<const TriangleMesh*>::const_iterator it_mesh = m_meshes.begin(); it_mesh != m_meshes.end(); ++ it_mesh) | ||||
| 		nfaces_total += (*it_mesh)->stl.stats.number_of_facets; | ||||
| 	m_faces.reserve(nfaces_total); | ||||
| 	for (std::vector<const TriangleMesh*>::const_iterator it_mesh = m_meshes.begin(); it_mesh != m_meshes.end(); ++ it_mesh) | ||||
| 		for (const stl_facet &face : (*it_mesh)->stl.facet_start) | ||||
| 			m_faces.emplace_back(&face); | ||||
|     m_faces.reserve(nfaces_total); | ||||
|     for (std::vector<const TriangleMesh*>::const_iterator it_mesh = m_meshes.begin(); it_mesh != m_meshes.end(); ++ it_mesh) | ||||
|         for (const stl_facet& face : (*it_mesh)->stl.facet_start) | ||||
|             m_faces.emplace_back(&face); | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| 	// 2) Sort faces lexicographically by their Z span.
 | ||||
| 	std::sort(m_faces.begin(), m_faces.end(), [](const stl_facet *f1, const stl_facet *f2) { | ||||
| 		std::pair<float, float> span1 = face_z_span(f1); | ||||
| 		std::pair<float, float> span2 = face_z_span(f2); | ||||
| 		return span1 < span2; | ||||
| 	}); | ||||
| 	std::sort(m_faces.begin(), m_faces.end(), [](const stl_facet *f1, const stl_facet *f2) { return face_z_span(f1) < face_z_span(f2); }); | ||||
| 
 | ||||
| 	// 3) Generate Z components of the facet normals.
 | ||||
| 	m_face_normal_z.assign(m_faces.size(), 0.f); | ||||
| 	m_face_normal_z.assign(m_faces.size(), 0.0f); | ||||
|     for (size_t iface = 0; iface < m_faces.size(); ++ iface) | ||||
|     	m_face_normal_z[iface] = m_faces[iface]->normal(2); | ||||
| } | ||||
| 
 | ||||
| float SlicingAdaptive::cusp_height(float z, float cusp_value, int ¤t_facet) | ||||
| { | ||||
| 	float height = m_slicing_params.max_layer_height; | ||||
| 	float height = (float)m_slicing_params.max_layer_height; | ||||
| 	bool first_hit = false; | ||||
| 	 | ||||
| 	// find all facets intersecting the slice-layer
 | ||||
| 	int ordered_id = current_facet; | ||||
| 	for (; ordered_id < int(m_faces.size()); ++ ordered_id) { | ||||
| 		std::pair<float, float> zspan = face_z_span(m_faces[ordered_id]); | ||||
| 		// facet's minimum is higher than slice_z -> end loop
 | ||||
|         std::pair<float, float> zspan = face_z_span(m_faces[ordered_id]); | ||||
|         // facet's minimum is higher than slice_z -> end loop
 | ||||
| 		if (zspan.first >= z) | ||||
| 			break; | ||||
| 		// facet's maximum is higher than slice_z -> store the first event for next cusp_height call to begin at this point
 | ||||
|  | @ -61,14 +83,14 @@ float SlicingAdaptive::cusp_height(float z, float cusp_value, int ¤t_facet | |||
| 			if (! first_hit) { | ||||
| 				first_hit = true; | ||||
| 				current_facet = ordered_id; | ||||
| 			} | ||||
|             } | ||||
| 			// skip touching facets which could otherwise cause small cusp values
 | ||||
| 			if (zspan.second <= z + EPSILON) | ||||
| 				continue; | ||||
| 			// compute cusp-height for this facet and store minimum of all heights
 | ||||
| 			float normal_z = m_face_normal_z[ordered_id]; | ||||
| 			height = std::min(height, (normal_z == 0.f) ? 9999.f : std::abs(cusp_value / normal_z)); | ||||
| 		} | ||||
|             height = std::min(height, (normal_z == 0.0f) ? (float)m_slicing_params.max_layer_height : std::abs(cusp_value / normal_z)); | ||||
|         } | ||||
| 	} | ||||
| 
 | ||||
| 	// lower height limit due to printer capabilities
 | ||||
|  | @ -77,8 +99,8 @@ float SlicingAdaptive::cusp_height(float z, float cusp_value, int ¤t_facet | |||
| 	// check for sloped facets inside the determined layer and correct height if necessary
 | ||||
| 	if (height > m_slicing_params.min_layer_height) { | ||||
| 		for (; ordered_id < int(m_faces.size()); ++ ordered_id) { | ||||
| 			std::pair<float, float> zspan = face_z_span(m_faces[ordered_id]); | ||||
| 			// facet's minimum is higher than slice_z + height -> end loop
 | ||||
|             std::pair<float, float> zspan = face_z_span(m_faces[ordered_id]); | ||||
|             // facet's minimum is higher than slice_z + height -> end loop
 | ||||
| 			if (zspan.first >= z + height) | ||||
| 				break; | ||||
| 
 | ||||
|  | @ -88,13 +110,13 @@ float SlicingAdaptive::cusp_height(float z, float cusp_value, int ¤t_facet | |||
| 
 | ||||
| 			// Compute cusp-height for this facet and check against height.
 | ||||
| 			float normal_z = m_face_normal_z[ordered_id]; | ||||
| 			float cusp = (normal_z == 0) ? 9999 : abs(cusp_value / normal_z); | ||||
| 			 | ||||
|             float cusp = (normal_z == 0.0f) ? (float)m_slicing_params.max_layer_height : std::abs(cusp_value / normal_z); | ||||
| 
 | ||||
| 			float z_diff = zspan.first - z; | ||||
| 
 | ||||
| 			// handle horizontal facets
 | ||||
| 			if (m_face_normal_z[ordered_id] > 0.999) { | ||||
| 				// Slic3r::debugf "cusp computation, height is reduced from %f", $height;
 | ||||
|             if (normal_z > 0.999f) { | ||||
|                 // Slic3r::debugf "cusp computation, height is reduced from %f", $height;
 | ||||
| 				height = z_diff; | ||||
| 				// Slic3r::debugf "to %f due to near horizontal facet\n", $height;
 | ||||
| 			} else if (cusp > z_diff) { | ||||
|  | @ -112,29 +134,30 @@ float SlicingAdaptive::cusp_height(float z, float cusp_value, int ¤t_facet | |||
| 		// lower height limit due to printer capabilities again
 | ||||
| 		height = std::max(height, float(m_slicing_params.min_layer_height)); | ||||
| 	} | ||||
| 	 | ||||
| 
 | ||||
| //	Slic3r::debugf "cusp computation, layer-bottom at z:%f, cusp_value:%f, resulting layer height:%f\n", unscale $z, $cusp_value, $height;	
 | ||||
| 	return height;  | ||||
| } | ||||
| 
 | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| // Returns the distance to the next horizontal facet in Z-dir 
 | ||||
| // to consider horizontal object features in slice thickness
 | ||||
| float SlicingAdaptive::horizontal_facet_distance(float z) | ||||
| { | ||||
| 	for (size_t i = 0; i < m_faces.size(); ++ i) { | ||||
| 		std::pair<float, float> zspan = face_z_span(m_faces[i]); | ||||
| 		// facet's minimum is higher than max forward distance -> end loop
 | ||||
|         std::pair<float, float> zspan = face_z_span(m_faces[i]); | ||||
|         // facet's minimum is higher than max forward distance -> end loop
 | ||||
| 		if (zspan.first > z + m_slicing_params.max_layer_height) | ||||
| 			break; | ||||
| 		// min_z == max_z -> horizontal facet
 | ||||
| 		if (zspan.first > z && zspan.first == zspan.second) | ||||
| 		if ((zspan.first > z) && (zspan.first == zspan.second)) | ||||
| 			return zspan.first - z; | ||||
| 	} | ||||
| 	 | ||||
| 	// objects maximum?
 | ||||
| 	return (z + m_slicing_params.max_layer_height > m_slicing_params.object_print_z_height()) ?  | ||||
| 		std::max<float>(m_slicing_params.object_print_z_height() - z, 0.f) : | ||||
| 		m_slicing_params.max_layer_height; | ||||
| 	return (z + (float)m_slicing_params.max_layer_height > (float)m_slicing_params.object_print_z_height()) ?  | ||||
| 		std::max((float)m_slicing_params.object_print_z_height() - z, 0.f) : (float)m_slicing_params.max_layer_height; | ||||
| } | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| }; // namespace Slic3r
 | ||||
|  |  | |||
|  | @ -5,29 +5,49 @@ | |||
| 
 | ||||
| #include "Slicing.hpp" | ||||
| #include "admesh/stl.h" | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| #include "TriangleMesh.hpp" | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| namespace Slic3r | ||||
| { | ||||
| 
 | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
| class ModelVolume; | ||||
| #else | ||||
| class TriangleMesh; | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| class SlicingAdaptive | ||||
| { | ||||
| public: | ||||
| 	void clear(); | ||||
| 	void set_slicing_parameters(SlicingParameters params) { m_slicing_params = params; } | ||||
| 	void add_mesh(const TriangleMesh *mesh) { m_meshes.push_back(mesh); } | ||||
| 	void prepare(); | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     void clear(); | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|     void set_slicing_parameters(SlicingParameters params) { m_slicing_params = params; } | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     void set_object(const ModelObject& object) { m_object = &object; } | ||||
| #else | ||||
|     void add_mesh(const TriangleMesh* mesh) { m_meshes.push_back(mesh); } | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|     void prepare(); | ||||
| 	float cusp_height(float z, float cusp_value, int ¤t_facet); | ||||
| 	float horizontal_facet_distance(float z); | ||||
| #if !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     float horizontal_facet_distance(float z); | ||||
| #endif // !ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
| 
 | ||||
| protected: | ||||
| 	SlicingParameters 					m_slicing_params; | ||||
| 
 | ||||
| 	std::vector<const TriangleMesh*>	m_meshes; | ||||
| 	// Collected faces of all meshes, sorted by raising Z of the bottom most face.
 | ||||
| #if ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE | ||||
|     const ModelObject*                  m_object; | ||||
|     TriangleMesh                        m_mesh; | ||||
| #else | ||||
|     std::vector<const TriangleMesh*>	m_meshes; | ||||
| #endif // ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE
 | ||||
|     // Collected faces of all meshes, sorted by raising Z of the bottom most face.
 | ||||
| 	std::vector<const stl_facet*>		m_faces; | ||||
| 	// Z component of face normals, normalized.
 | ||||
|     // Z component of face normals, normalized.
 | ||||
| 	std::vector<float>					m_face_normal_z; | ||||
| }; | ||||
| 
 | ||||
|  |  | |||
|  | @ -26,8 +26,6 @@ | |||
| 
 | ||||
| // Disable synchronization of unselected instances
 | ||||
| #define DISABLE_INSTANCES_SYNCH (0 && ENABLE_1_42_0_ALPHA1) | ||||
| // Disable imgui dialog for move, rotate and scale gizmos
 | ||||
| #define DISABLE_MOVE_ROTATE_SCALE_GIZMOS_IMGUI (1 && ENABLE_1_42_0_ALPHA1) | ||||
| // Use wxDataViewRender instead of wxDataViewCustomRenderer
 | ||||
| #define ENABLE_NONCUSTOM_DATA_VIEW_RENDERING (0 && ENABLE_1_42_0_ALPHA1) | ||||
| 
 | ||||
|  | @ -38,8 +36,21 @@ | |||
| #define ENABLE_2_2_0_ALPHA1 1 | ||||
| 
 | ||||
| // Enable thumbnail generator
 | ||||
| // When removing this technology, remove it also from stable branch, 
 | ||||
| // where it has been partially copied for patch 2.1.1
 | ||||
| #define ENABLE_THUMBNAIL_GENERATOR (1 && ENABLE_2_2_0_ALPHA1) | ||||
| #define ENABLE_THUMBNAIL_GENERATOR_DEBUG (0 && ENABLE_THUMBNAIL_GENERATOR) | ||||
| #define ENABLE_THUMBNAIL_GENERATOR_PNG_TO_GCODE (1 && ENABLE_THUMBNAIL_GENERATOR) | ||||
| 
 | ||||
| // Enable adaptive layer height profile
 | ||||
| #define ENABLE_ADAPTIVE_LAYER_HEIGHT_PROFILE (1 && ENABLE_2_2_0_ALPHA1) | ||||
| 
 | ||||
| // Enable grayed variant for gizmos icons in non activable state
 | ||||
| #define ENABLE_GIZMO_ICONS_NON_ACTIVABLE_STATE (1 && ENABLE_2_2_0_ALPHA1) | ||||
| 
 | ||||
| // Enable fix for view toolbar background not showing up on Mac with dark mode
 | ||||
| #define ENABLE_VIEW_TOOLBAR_BACKGROUND_FIX (1 && ENABLE_2_2_0_ALPHA1) | ||||
| 
 | ||||
| // Enable selection for missing files in reload from disk command
 | ||||
| #define ENABLE_RELOAD_FROM_DISK_MISSING_SELECTION (1 && ENABLE_2_2_0_ALPHA1) | ||||
| 
 | ||||
| #endif // _technologies_h_
 | ||||
|  |  | |||
|  | @ -198,6 +198,29 @@ private: | |||
|     void make_expolygons(std::vector<IntersectionLine> &lines, const float closing_radius, ExPolygons* slices) const; | ||||
| }; | ||||
| 
 | ||||
| inline void slice_mesh( | ||||
|     const TriangleMesh &                              mesh, | ||||
|     const std::vector<float> &                        z, | ||||
|     std::vector<Polygons> &                           layers, | ||||
|     TriangleMeshSlicer::throw_on_cancel_callback_type thr = nullptr) | ||||
| { | ||||
|     if (mesh.empty()) return; | ||||
|     TriangleMeshSlicer slicer(&mesh); | ||||
|     slicer.slice(z, &layers, thr); | ||||
| } | ||||
| 
 | ||||
| inline void slice_mesh( | ||||
|     const TriangleMesh &                              mesh, | ||||
|     const std::vector<float> &                        z, | ||||
|     std::vector<ExPolygons> &                         layers, | ||||
|     float                                             closing_radius, | ||||
|     TriangleMeshSlicer::throw_on_cancel_callback_type thr = nullptr) | ||||
| { | ||||
|     if (mesh.empty()) return; | ||||
|     TriangleMeshSlicer slicer(&mesh); | ||||
|     slicer.slice(z, closing_radius, &layers, thr); | ||||
| } | ||||
| 
 | ||||
| TriangleMesh make_cube(double x, double y, double z); | ||||
| 
 | ||||
| // Generate a TriangleMesh of a cylinder
 | ||||
|  |  | |||
		Loading…
	
	Add table
		Add a link
		
	
		Reference in a new issue
	
	 Lukas Matena
						Lukas Matena